19. Standard Forces¶
The following classes implement standard force field terms that are widely used in molecular simulations.
19.1. HarmonicBondForce¶
Each harmonic bond is represented by an energy term of the form
where x is the distance between the two particles, x0 is the equilibrium distance, and k is the force constant. This produces a force of magnitude k(x-x0).
Be aware that some force fields define their harmonic bond parameters in a slightly different way: E = k´(x-x0)2, leading to a force of magnitude 2k´(x-x0). Comparing these two forms, you can see that k = 2k´. Be sure to check which form a particular force field uses, and if necessary multiply the force constant by 2.
19.2. HarmonicAngleForce¶
Each harmonic angle is represented by an energy term of the form
where
As with HarmonicBondForce, be aware that some force fields define their harmonic
angle parameters as E = k´(
19.3. PeriodicTorsionForce¶
Each torsion is represented by an energy term of the form
where
19.4. RBTorsionForce¶
Each torsion is represented by an energy term of the form
where
For reason of convention, PeriodicTorsionForce and RBTorsonForce define the
torsion angle differently.
19.5. CMAPTorsionForce¶
Each torsion pair is represented by an energy term of the form
where
19.6. NonbondedForce¶
19.6.1. Lennard-Jones Interaction¶
The Lennard-Jones interaction between each pair of particles is represented by an energy term of the form
where r is the distance between the two particles,
Optionally you can use a switching function to make the energy go smoothly to 0
at the cutoff distance. When
where
When an exception has been added for a pair of particles,
When using periodic boundary conditions, NonbondedForce can optionally add a term (known as a long range dispersion correction) to the energy that approximately represents the contribution from all interactions beyond the cutoff distance:[44]
where N is the number of particles in the system, V is the volume of
the periodic box,
The Lennard-Jones interaction is often parameterized in two other equivalent ways. One is
where
In turn,
Another common form is
The coefficients A and B are related to
19.6.2. Coulomb Interaction Without Cutoff¶
The form of the Coulomb interaction between each pair of particles depends on the NonbondedMethod in use. For NoCutoff, it is given by
where q1 and q2 are the charges of the two particles, and r is the distance between them.
19.6.3. Coulomb Interaction With Cutoff¶
For CutoffNonPeriodic or CutoffPeriodic, it is modified using the reaction field approximation. This is derived by assuming everything beyond the cutoff distance is a solvent with a uniform dielectric constant.[45]
where
The reaction field approximation is not applied to nonbonded exceptions. They are always evaluated at full strength, regardless of the cutoff distance. That is because exceptions are primarily used to model 1-4 interactions, which are really a type of bonded interaction. They are typically parametrized without a cutoff together with the other bonded interactions.
19.6.4. Coulomb Interaction With Ewald Summation¶
For Ewald, the total Coulomb energy is the sum of three terms: the direct space sum, the reciprocal space sum, and the self-energy term.[46]
In the above expressions, the indices i and j run over all
particles, n = (n1, n2, n3) runs over
all copies of the periodic cell, and k = (k1, k2,
k3) runs over all integer wave vectors from (-kmax,
-kmax, -kmax) to (kmax, kmax,
kmax) excluding (0, 0, 0).
In the direct space sum, all pairs that are further apart than the cutoff distance are ignored. Because the cutoff is required to be less than half the width of the periodic cell, the number of terms in this sum is never greater than the square of the number of particles.
The error made by applying the direct space cutoff depends on the magnitude of
Instead of having the user specify
Finally, it estimates the error in the reciprocal space sum as
where d is the width of the periodic box, and selects the smallest value
for kmax which gives error <
This means that the accuracy of the calculation is determined by
Be aware that the error tolerance
19.6.5. Coulomb Interaction With Particle Mesh Ewald¶
The Particle Mesh Ewald (PME) algorithm[47] is similar to Ewald summation, but instead of calculating the reciprocal space sum directly, it first distributes the particle charges onto nodes of a rectangular mesh using 5th order B-splines. By using a Fast Fourier Transform, the sum can then be computed very quickly, giving performance that scales as O(N log N) in the number of particles (assuming the volume of the periodic box is proportional to the number of particles).
As with Ewald summation, the user specifies the direct space cutoff
and the number of nodes in the mesh along each dimension as
where d is the width of the periodic box along that dimension. Alternatively,
the user may choose to explicitly set values for these parameters. (Note that
some Platforms may choose to use a larger value of
The comments in the previous section regarding the interpretation of
19.6.6. Lennard-Jones Interaction With Particle Mesh Ewald¶
The PME algorithm can also be used for Lennard-Jones interactions. Usually this is not necessary, since Lennard-Jones forces are short ranged, but there are situations (such as membrane simulations) where neglecting interactions beyond the cutoff can measurably affect results.
For computational efficiency, certain approximations are made[48].
Interactions beyond the cutoff distance include only the attractive
The effect of this approximation is also quite small, and it is still far more accurate than ignoring the interactions altogether (which is what would happen with PME).
The formula used to compute the number of nodes along each dimension of the mesh is slightly different from the one used for Coulomb interactions:
As before, this is an empirical formula. It will usually produce an average
relative error in the forces less than or similar to
19.7. GBSAOBCForce¶
19.7.1. Generalized Born Term¶
GBSAOBCForce consists of two energy terms: a Generalized Born Approximation term to represent the electrostatic interaction between the solute and solvent, and a surface area term to represent the free energy cost of solvating a neutral molecule. The Generalized Born energy is given by[16]
where the indices i and j run over all particles,
where
where
19.7.2. Surface Area Term¶
The surface area term is given by[49][50]
where
19.8. GayBerneForce¶
This is similar to the Lennard-Jones interaction described in section 19.6.1,
but instead of being based on the distance between two point particles, it is based
on the distance of closest approach between two ellipsoids.[51]
Let
The energy is computed as a product of three terms:
The first term describes the distance dependence, and is very similar in form to the Lennard-Jones interaction:
where
The second term adjusts the energy based on the relative orientations of the two ellipsoids:
The third term applies the user-defined scale factors
When using a cutoff, you can optionally use a switching function to make the energy go smoothly to 0
at the cutoff distance. When
where
19.9. AndersenThermostat¶
AndersenThermostat couples the system to a heat bath by randomly selecting a subset of particles at the start of each time step, then setting their velocities to new values chosen from a Boltzmann distribution. This represents the effect of random collisions between particles in the system and particles in the heat bath.[52]
The probability that a given particle will experience a collision in a given time step is
where f is the collision frequency and
where T is the thermostat temperature, m is the particle mass, and R is a random number chosen from a normal distribution with mean of zero and variance of one.
19.10. MonteCarloBarostat¶
MonteCarloBarostat models the effect of constant pressure by allowing the size
of the periodic box to vary with time.[53][54]
At regular intervals, it attempts a Monte Carlo step by scaling the box vectors
and the coordinates of each molecule’s center by a factor s. The scale
factor s is chosen to change the volume of the periodic box from V
to V+
The change in volume is chosen randomly as
where A is a scale factor and r is a random number uniformly distributed between -1 and 1. The step is accepted or rejected based on the weight function
where
This algorithm tends to be more efficient than deterministic barostats such as the Berendsen or Parrinello-Rahman algorithms, since it does not require an expensive virial calculation at every time step. Each Monte Carlo step involves two energy evaluations, but this can be done much less often than every time step. It also does not require you to specify the compressibility of the system, which usually is not known in advance.
The scale factor A that determines the size of the steps is chosen automatically to produce an acceptance rate of approximately 50%. It is initially set to 1% of the periodic box volume. The acceptance rate is then monitored, and if it varies too much from 50% then A is modified accordingly.
Each Monte Carlo step modifies particle positions by scaling the centroid of each molecule, then applying the resulting displacement to each particle in the molecule. This ensures that each molecule is translated as a unit, so bond lengths and constrained distances are unaffected.
MonteCarloBarostat assumes the simulation is being run at constant temperature as well as pressure, and the simulation temperature affects the step acceptance probability. It does not itself perform temperature regulation, however. You must use another mechanism along with it to maintain the temperature, such as LangevinIntegrator or AndersenThermostat.
19.11. MonteCarloAnisotropicBarostat¶
MonteCarloAnisotropicBarostat is very similar to MonteCarloBarostat, but instead of scaling the entire periodic box uniformly, each Monte Carlo step scales only one axis of the box. This allows the box to change shape, and is useful for simulating anisotropic systems whose compressibility is different along different directions. It also allows a different pressure to be specified for each axis.
You can specify that the barostat should only be applied to certain axes of the box, keeping the other axes fixed. This is useful, for example, when doing constant surface area simulations of membranes.
19.12. MonteCarloMembraneBarostat¶
MonteCarloMembraneBarostat is very similar to MonteCarloBarostat, but it is specialized for simulations of membranes. It assumes the membrane lies in the XY plane. In addition to applying a uniform pressure to regulate the volume of the periodic box, it also applies a uniform surface tension to regulate the cross sectional area of the periodic box in the XY plane. The weight function for deciding whether to accept a step is
where S is the surface tension and
MonteCarloMembraneBarostat offers some additional options to customize the behavior of the periodic box:
The X and Y axes can be either
isotropic (they are always scaled by the same amount, so their ratio remains fixed)
anisotropic (they can change size independently)
The Z axis can be either
free (its size changes independently of the X and Y axes)
fixed (its size does not change)
inversely varying with the X and Y axes (so the total box volume does not change)
19.13. MonteCarloFlexibleBarostat¶
MonteCarloFlexibleBarostat is very similar to MonteCarloBarostat, but it allows the periodic box to be fully flexible.[55] Monte Carlo steps can change not just the lengths of the box sides, but also the angles. It is especially useful for simulations of bulk materials where the shape of a crystal’s unit cell may not be known in advance, or could even change with time as it transitions between phases.
19.14. CMMotionRemover¶
CMMotionRemover prevents the system from drifting in space by periodically removing all center of mass motion. At the start of every n’th time step (where n is set by the user), it calculates the total center of mass velocity of the system:
where
19.15. RMSDForce¶
RMSDForce computes the root-mean-squared deviation (RMSD) between the current
particle positions
Before computing this, the reference positions are first translated and rotated
so as to minimize the RMSD. The computed value is therefore
This force is normally used with a CustomCVForce (see Section 20.11). One rarely wants a force whose energy exactly equals the RMSD, but there are many situations where it is useful to have a restraining or biasing force that depends on the RMSD in some way.