Class List

Here are the classes, structs, unions and interfaces with brief descriptions:
AmberInpcrdFileAmberInpcrdFile parses an AMBER inpcrd file and loads the data stored in it
AmberPrmtopFileAmberPrmtopFile parses an AMBER prmtop file and constructs a Topology and (optionally) an OpenMM System from it
AmoebaGeneralizedKirkwoodForceThis class implements an implicit solvation force using the generalized Kirkwood/OBC model
AmoebaHarmonicAngleForceThis class implements an interaction between triplets of particles that varies harmonically with the angle between them
AmoebaHarmonicBondForceThis class implements an interaction between pairs of particles that varies harmonically with the distance between them
AmoebaHarmonicInPlaneAngleForceThis class implements an interaction at trigonal centers corresponding to the projected in-plane angle bend energy between four particles; the energy varies harmonically with the angle between them
AmoebaMultipoleForceThis class implements the Amoeba multipole interaction To use it, create a MultipoleForce object then call addMultipole() once for each atom
AmoebaOutOfPlaneBendForceThis class implements the Amoeba Out-of-plane bend interaction To use it, create a OutOfPlaneBendForce object then call addOutOfPlaneBend() once for each outOfPlaneBend
AmoebaPiTorsionForceThis class implements the Amoeba pi-torsion interaction To use it, create a PiTorsionForce object then call addPiTorsion() once for each torsion
AmoebaStretchBendForceThis class implements the Amoeba stretch bend interaction To use it, create a StretchBendForce object then call addStretchBend() once for each stretchBend
AmoebaTorsionForceThis class implements an torsion interaction among four particles
AmoebaTorsionTorsionForceThis class implements the Amoeba torsion-torsion interaction To use it, create a TorsionTorsionForce object then call addTorsionTorsion() once for each torsionTorsion
AmoebaUreyBradleyForceThis class implements an interaction between pairs of particles that varies harmonically with the distance between them
AmoebaVdwForceThis class implements an interaction between pairs of particles that varies harmonically with the distance between them
AmoebaWcaDispersionForceThis class implements an interaction between pairs of particles that varies harmonically with the distance between them
AndersenThermostatThis class uses the Andersen method to maintain constant temperature
AtomAn Atom object represents a residue within a Topology
BrownianIntegratorThis is an Integrator which simulates a System using Brownian dynamics
ChainA Chain object represents a chain within a Topology
CMAPTorsionForceThis class implements an interaction between pairs of dihedral angles
CMMotionRemoverThis class prevents the center of mass of a System from drifting
ContextA Context stores the complete state of a simulation
CustomAngleForceThis class implements interactions between sets of three particles that depend on the angle between them
CustomBondForceThis class implements bonded interactions between pairs of particles
CustomExternalForceThis class implements an "external" force on particles
CustomGBForceThis class implements complex, multiple stage nonbonded interactions between particles
CustomHbondForceThis class supports a wide variety of energy functions used to represent hydrogen bonding
CustomIntegratorThis is an Integrator that can be used to implemented arbitrary, user defined integration algorithms
CustomNonbondedForceThis class implements nonbonded interactions between particles
CustomTorsionForceThis class implements interactions between sets of four particles that depend on the torsion angle between them
DCDFileDCDFile provides methods for creating DCD files
DCDReporterDCDReporter outputs a series of frames from a Simulation to a DCD file
ElementAn Element represents a chemical element
ForceForce objects apply forces to the particles in a System, or alter their behavior in other ways
ForceFieldA ForceField constructs OpenMM System objects based on a Topology
GBSAOBCForceThis class implements an implicit solvation force using the GBSA-OBC model
GBSAOBCSoftcoreForceThis class implements an implicit solvation force using the GBSA-OBC model
GBVIForceThis class implements an implicit solvation force using the GB/VI model
GBVISoftcoreForceThis class implements an implicit solvation force using the GB/VI model
HarmonicAngleForceThis class implements an interaction between groups of three particles that varies harmonically with the angle between them
HarmonicBondForceThis class implements an interaction between pairs of particles that varies harmonically with the distance between them
IntegratorAn Integrator defines a method for simulating a System by integrating the equations of motion
LangevinIntegratorThis is an Integrator which simulates a System using Langevin dynamics
LocalEnergyMinimizerGiven a Context, this class searches for a new set of particle positions that represent a local minimum of the potential energy
ModellerModeller provides tools for editing molecular models, such as adding water or missing hydrogens
MonteCarloBarostatThis class uses a Monte Carlo algorithm to adjust the size of the periodic box, simulating the effect of constant pressure
NonbondedForceThis class implements nonbonded interactions between particles, including a Coulomb force to represent electrostatics and a Lennard-Jones force to represent van der Waals interactions
NonbondedSoftcoreForceThis class implements nonbonded interactions between particles, including a Coulomb force to represent electrostatics and a Lennard-Jones force to represent van der Waals interactions
OpenMMExceptionThis class is used for all exceptions thrown by OpenMM
OutOfPlaneSiteThis is a VirtualSite that computes the particle location based on three other particles' locations
PDBFilePDBFile parses a Protein Data Bank (PDB) file and constructs a Topology and a set of atom positions from it
PDBReporterPDBReporter outputs a series of frames from a Simulation to a PDB file
PeriodicTorsionForceThis class implements an interaction between groups of four particles that varies periodically with the torsion angle between them
PlatformA Platform defines an implementation of all the kernels needed to perform some calculation
RBTorsionForceThis class implements an interaction between groups of four particles that varies with the torsion angle between them according to the Ryckaert-Bellemans potential
ResidueA Residue object represents a residue within a Topology
RPMDIntegratorThis is an Integrator which simulates a System using ring polymer molecular dynamics (RPMD)
SimulationSimulation provides a simplified API for running simulations with OpenMM and reporting results
StateA State object records a snapshot of the current state of a simulation at a point in time
StateDataReporterStateDataReporter outputs information about a simulation, such as energy and temperature, to a file
SystemThis class represents a molecular system
ThreeParticleAverageSiteThis is a VirtualSite that computes the particle location as a weighted average of three other particle's locations
TopologyTopology stores the topological information about a system
TwoParticleAverageSiteThis is a VirtualSite that computes the particle location as a weighted average of two other particle's locations
VariableLangevinIntegratorThis is an error contolled, variable time step Integrator that simulates a System using Langevin dynamics
VariableVerletIntegratorThis is an error contolled, variable time step Integrator that simulates a System using the leap-frog Verlet algorithm
Vec3Vec3 is a 3-element tuple that supports many math operations
VerletIntegratorThis is an Integrator which simulates a System using the leap-frog Verlet algorithm
VirtualSiteA VirtualSite describes the rules for computing a particle's position based on other particles
XmlSerializerXmlSerializer is used for serializing objects as XML, and for reconstructing them again

Generated by  doxygen 1.6.2