OpenMM
|
Topology stores the topological information about a system. More...
Public Member Functions | |
def | __init__ |
Create a new Topology object. More... | |
def | addChain |
Create a new Chain and add it to the Topology. More... | |
def | addResidue |
Create a new Residue and add it to the Topology. More... | |
def | addAtom |
Create a new Atom and add it to the Topology. More... | |
def | addBond |
Create a new bond and add it to the Topology. More... | |
def | chains |
Iterate over all Chains in the Topology. More... | |
def | residues |
Iterate over all Residues in the Topology. More... | |
def | atoms |
Iterate over all Atoms in the Topology. More... | |
def | bonds |
Iterate over all bonds (each represented as a tuple of two Atoms) in the Topology. More... | |
def | getUnitCellDimensions |
Get the dimensions of the crystallographic unit cell. More... | |
def | setUnitCellDimensions |
Set the dimensions of the crystallographic unit cell. More... | |
def | createStandardBonds |
Create bonds based on the atom and residue names for all standard residue types. More... | |
def | createDisulfideBonds |
Identify disulfide bonds based on proximity and add them to the Topology. More... | |
Static Public Member Functions | |
def | loadBondDefinitions |
Load an XML file containing definitions of bonds that should be used by createStandardBonds(). More... | |
Topology stores the topological information about a system.
The structure of a Topology object is similar to that of a PDB file. It consists of a set of Chains (often but not always corresponding to polymer chains). Each Chain contains a set of Residues, and each Residue contains a set of Atoms. In addition, the Topology stores a list of which atom pairs are bonded to each other, and the dimensions of the crystallographic unit cell.
Atom and residue names should follow the PDB 3.0 nomenclature for all molecules for which one exists.
def __init__ | ( | self | ) |
Create a new Topology object.
References Topology._bonds, Topology._chains, Topology._numAtoms, Topology._numResidues, Topology._unitCellDimensions, and GromacsGroFile._unitCellDimensions.
def addAtom | ( | self, | |
name, | |||
element, | |||
residue | |||
) |
def addBond | ( | self, | |
atom1, | |||
atom2 | |||
) |
Create a new bond and add it to the Topology.
atom1 | (Atom) The first Atom connected by the bond |
atom2 | (Atom) The second Atom connected by the bond |
Referenced by Topology.createDisulfideBonds(), and Topology.createStandardBonds().
def addChain | ( | self | ) |
def addResidue | ( | self, | |
name, | |||
chain | |||
) |
def atoms | ( | self | ) |
Iterate over all Atoms in the Topology.
References Topology._chains.
Referenced by ForceField.registerScript().
def bonds | ( | self | ) |
Iterate over all bonds (each represented as a tuple of two Atoms) in the Topology.
References Topology._bonds.
Referenced by ForceField.registerScript().
def chains | ( | self | ) |
Iterate over all Chains in the Topology.
References Topology._chains.
def createDisulfideBonds | ( | self, | |
positions | |||
) |
Identify disulfide bonds based on proximity and add them to the Topology.
positions | (list) The list of atomic positions based on which to identify bonded atoms |
References Topology.addBond(), ForceField._TemplateData.addBond(), CustomBondForce.addBond(), CustomCompoundBondForce.addBond(), AmoebaBondForce.addBond(), HarmonicBondForce.addBond(), GBVIForce.addBond(), and Topology.residues().
def createStandardBonds | ( | self | ) |
Create bonds based on the atom and residue names for all standard residue types.
Definitions for standard amino acids and nucleotides are built in. You can call loadBondDefinitions() to load additional definitions for other residue types.
References Topology._chains, Topology.addBond(), ForceField._TemplateData.addBond(), CustomBondForce.addBond(), CustomCompoundBondForce.addBond(), AmoebaBondForce.addBond(), HarmonicBondForce.addBond(), and GBVIForce.addBond().
def getUnitCellDimensions | ( | self | ) |
Get the dimensions of the crystallographic unit cell.
The return value may be None if this Topology does not represent a periodic structure.
References Topology._unitCellDimensions, and GromacsGroFile._unitCellDimensions.
|
static |
Load an XML file containing definitions of bonds that should be used by createStandardBonds().
The built in residues.xml file containing definitions for standard amino acids and nucleotides is loaded automatically. This method can be used to load additional definitions for other residue types. They will then be used in subsequent calls to createStandardBonds(). This is a static method, so it affects subsequent calls on all Topology objects. Also note that PDBFile calls createStandardBonds() automatically when a file is loaded, so the newly loaded definitions will be used for any PDB file loaded after this is called.
def residues | ( | self | ) |
Iterate over all Residues in the Topology.
References Topology._chains.
Referenced by Topology.createDisulfideBonds().
def setUnitCellDimensions | ( | self, | |
dimensions | |||
) |
Set the dimensions of the crystallographic unit cell.
References Topology._unitCellDimensions, and GromacsGroFile._unitCellDimensions.