Home | Trees | Indices | Help |
|
---|
|
|
|||
| __init__(self, rec_model=None, lig_model=None, ligMatrix=None, info={}) | ||
str
|
version(self) Version of Dock.Complex |
||
|
__getstate__(self) Called before pickling. |
||
dict
|
__getitem__(self,
key) Returns C.info[ key ] |
||
| __setitem__(self, key, v) | ||
| __delitem__(self, key) | ||
| __contains__(self, key) | ||
|
__setstate__(self,
state) called for unpickling the object. |
||
|
__defaults(self) backwards compatibility to earlier pickled models |
||
[str]
|
keys(self) Keys of info dictionary. |
||
1|0
|
has_key(self,
k) Check if info dictionary has key. |
||
[any]
|
values(self,
keys=[],
default=None) Use: |
||
any OR None
|
get(self,
key,
default=None) Use: |
||
PCRModel
|
rec(self) Return PCRModel object. |
||
PCRModel
|
lig(self,
force=0,
cache=1) Return ligand structure transformed. |
||
PCRModel
|
model(self) Model with both receptor and ligand. |
||
array, vector
|
ligMatrix(self) Return transformation matrix to transform original Ligand PCRModel into docked conformation. |
||
|
setLigMatrix(self,
m) Set a ligand translation/rotation matrix. |
||
dict
|
getInfo(self) Return contents of the info dictionary. |
||
|
writeLigand(self,
fname,
ter=0) Write transformed ligand to pdb file. |
||
|
writeReceptor(self,
fname,
ter=0) Write receptor to pdb without TER statement (unless removeTer!=0). |
||
|
writeComplex(self,
fname,
ter=0) Write single pdb containing both receptor and ligand separated by END but not TER (unless ter!=0). |
||
|
slim(self) Remove coordinates and atoms of ligand and receptor from memory, if they can be restored from file, compress contact matrix. |
||
float
|
contactsOverlap(self,
ref,
cutoff=None) Fraction of overlapping residue-residue contacts between this and reference complex. |
||
int
|
contactsShared(self,
reference,
cutoff=None) Number of equal residue-residue contacts in this and reference complex. |
||
int
|
contactsDiff(self,
ref,
cutoff=None) Number of different residue-residue contacts in this and reference complex. |
||
float
|
fractionNativeContacts(self,
ref,
cutoff=None) Fraction of native residue-residue contacts. |
||
(float, float)
|
fractionNativeSurface(self,
cont,
contRef) fraction of atoms/residues that are involved in any contacts in both complexes. |
||
float
|
rmsLig(self,
ref) Rms of ligand from reference ligand after superimposing the two receptors. |
||
float
|
rmsInterface(self,
ref,
cutoff=4.5,
fit=1) Rmsd between this and reference interface. |
||
[(str.str)..]
|
contactResPairs(self,
cm=None) Get list of residue names paired up in contacts. |
||
dict
|
contactResDistribution(self,
cm=None) Count occurrence of residues in protein-protein interface. |
||
dict
|
contactTypeDistribution(self,
cm=None) Count occurrence of residue types aromatic (a), charged(c), polar(p), else/unpolar(u). |
||
dict
|
resPairCounts(self,
cm=None) Count how often (all possible) res-res combinations occur in the given contacts. |
||
dict OR None
|
loadResContacts(self) Uncompress residue contact matrix if necessary. |
||
array
|
resContacts(self,
cutoff=4.5,
maskRec=None,
maskLig=None,
refComplex=None,
force=0,
cache=1,
cache_pw=0) Matrix of all residue - residue contacts between receptor and ligand. |
||
2D array
|
__alignMatrixDimension(self,
cm,
thisSeq,
castSeq,
axis=0) Correct one dimension of contactMatrix by inserting and deleting columns, so that it can be later compared to contact matrices based on slightly different sequences. |
||
array
|
__unmaskedMatrix(self,
contacts,
rec_mask,
lig_mask) Map contacts between selected rec and lig atoms back to all atoms matrix. |
||
array
|
__atomContacts(self,
cutoff,
rec_mask,
lig_mask,
cache) Intermolecular distances below cutoff after applying the two masks. |
||
array
|
atomContacts(self,
cutoff=4.5,
rec_mask=None,
lig_mask=None,
cache=0,
map_back=1) Find all inter-molecular atom-atom contacts between rec and lig |
||
array
|
__resContacts(self,
cutoff,
maskRec=None,
maskLig=None,
cache=0) Find all inter-molecule residue-residue contacts between receptor and ligand. |
||
array
|
__atom2residueMatrix(self,
m) Reduce binary matrix of n x k atoms to binary matrix of i x j residues. |
||
[1|0], [1|0], [1|0], [1|0]
|
equalAtoms(self,
ref) Compare two complexes' atom content of receptor and ligand. |
||
[int], [int], [int], [int]
|
compareAtoms(self,
ref) Compare atom content and oder of rec and lig of 2 complexes. |
||
Complex
|
take(self,
rec_pos,
lig_pos) Get copy of this complex with given atoms of rec and lig. |
||
Complex
|
compress(self,
rec_mask,
lig_mask) Compress complex using a rec and lig mask. |
||
float
|
contPairScore(self,
cutoff=6.0) Score interaction surface residue pairs. |
||
(float, float) or dict
|
interfaceArea(self,
profiles=0,
log=StdLog(),
verbose=1) Calculate the difference between the surface area of the complex vs. |
||
(array, array, array)
|
prosa2003Energy(self) Calculate Prosa2003 total energies for the complex. |
||
dict
|
foldXEnergy(self,
force=1) Calculate E_rec and/or E_lig only if not given: |
||
float
|
conservationScore(self,
cons_type='cons_ent',
ranNr=150,
log=StdLog(),
verbose=1) Score of conserved residue pairs in the interaction surface. |
||
array
|
rtTuple2matrix(self,
r,
t) Put rotation and translation matrix into single 4x4 matrix. |
||
array
|
extractLigandMatrix(self,
lig) Find transformation matrix for rigid body-transformed ligand. |
||
array, array
|
__findTransformation(self,
x,
y) Match two arrays by rotation and translation. |
||
array
|
__pairwiseDistances(self,
u,
v) pairwise distance between 2 3-D numpy arrays of atom coordinates. |
||
(array, array)
|
__extractLigandMatrix(self,
fcomplex) Compare structure from hex complex with original ligand pdb and store transformation matrix of ligand in self.ligandMatrix. |
|
|
Version of Dock.Complex
|
Called before pickling. |
|
|
|
|
called for unpickling the object. |
backwards compatibility to earlier pickled models |
Keys of info dictionary.
|
Check if info dictionary has key.
|
Use: values( keys=None, default=None ) -> list of info dict values
|
Use: C.get(k[,default]) -> C.info[k] if C.info.has_key(k), else default defaults to None.
|
Return PCRModel object.
|
Return ligand structure transformed. Use cached object, if available.
|
Model with both receptor and ligand.
|
Return transformation matrix to transform original Ligand PCRModel into docked conformation.
|
Set a ligand translation/rotation matrix.
|
Return contents of the info dictionary.
|
Write transformed ligand to pdb file. Remove TER record for xplor usage (unless removeTer!=0).
|
Write receptor to pdb without TER statement (unless removeTer!=0).
|
Write single pdb containing both receptor and ligand separated by END but not TER (unless ter!=0).
|
Remove coordinates and atoms of ligand and receptor from memory, if they can be restored from file, compress contact matrix.
|
Fraction of overlapping residue-residue contacts between this and reference complex.
|
Number of equal residue-residue contacts in this and reference complex.
|
Number of different residue-residue contacts in this and reference complex.
|
Fraction of native residue-residue contacts.
|
fraction of atoms/residues that are involved in any contacts in both complexes.
|
Rms of ligand from reference ligand after superimposing the two receptors.
|
Rmsd between this and reference interface. The interface is defined as any residue that has an atom which is within the distance given by |cutoff| from its partner.
|
Get list of residue names paired up in contacts.
|
Count occurrence of residues in protein-protein interface.
|
Count occurrence of residue types aromatic (a), charged(c), polar(p), else/unpolar(u).
|
Count how often (all possible) res-res combinations occur in the given contacts.
|
Uncompress residue contact matrix if necessary.
|
Matrix of all residue - residue contacts between receptor and ligand. Result is cached.
|
Correct one dimension of contactMatrix by inserting and deleting columns, so that it can be later compared to contact matrices based on slightly different sequences.
|
Map contacts between selected rec and lig atoms back to all atoms matrix.
|
Intermolecular distances below cutoff after applying the two masks.
|
Find all inter-molecular atom-atom contacts between rec and lig
|
Find all inter-molecule residue-residue contacts between receptor and ligand. A contact between A and B is set if any heavy atom of A is within |cutoff| A of B.
|
Reduce binary matrix of n x k atoms to binary matrix of i x j residues.
|
Compare two complexes' atom content of receptor and ligand. Apply to SORTED models without HETATOMS. Coordinates are not checked.
|
Compare atom content and oder of rec and lig of 2 complexes. Get list of all atom positions of rec and lig in both complexes that have a matching atom (by residue and atom name) in the other complex. Indices for this complex are returned in the right oder to match the atom order of ref. I.e., in contrast to equalAtoms, castAtoms can equalize two complexes where atoms are ordered differently within the residues.
|
Get copy of this complex with given atoms of rec and lig.
|
Compress complex using a rec and lig mask.
|
Score interaction surface residue pairs. Info on Scoring matrix see Biskit.molUtils
|
Calculate the difference between the surface area of the complex vs. its free components in square angstrom.
|
Calculate Prosa2003 total energies for the complex.
|
Calculate E_rec and/or E_lig only if not given: E_com - (E_rec + E_lig).
|
Score of conserved residue pairs in the interaction surface. Optionally, normalized by radom surface contacts.
|
Put rotation and translation matrix into single 4x4 matrix.
|
Find transformation matrix for rigid body-transformed ligand.
|
Match two arrays by rotation and translation. Returns the rotation matrix and the translation vector. Back transformation: for atom i new coordinates will be: y_new[i] = N.dot(r, y[i]) + tfor all atoms in one step: y_new = N.dot(y, N.transpose(r)) + t
|
pairwise distance between 2 3-D numpy arrays of atom coordinates.
|
Compare structure from hex complex with original ligand pdb and store transformation matrix of ligand in self.ligandMatrix.
|
Home | Trees | Indices | Help |
|
---|
Generated by Epydoc 3.0alpha3 on Tue May 1 22:34:52 2007 | http://epydoc.sourceforge.net |