Download Notebook View in GitHub Open in Google Colab
Using OpenFF force fields in Amber and GROMACS
The Open Forcefield Toolkit can create parametrized openmm.System
objects that can be natively simulated with OpenMM. This example shows the Interchange project can enable parallel workflows using Amber and GROMACS.
Preparing an OpenFF Topology
We start by loading a PDB file containing one copy of ethanol and cyclohexane. Our goal is to create an OpenFF Topology
object describing this system that we can parametrize with the SMIRNOFF-format “Sage” force field.
The two Molecule
objects created from the SMILES strings can contain information such as formal charges and stereochemistry that is not included in a PDB file. These objects are passed to the PDB loading function via the unique_molecules
argument. In this example, partial charges are not explicitly given, and ForceField
will assign AM1/BCC charges as specified by the “Sage” force field. Note that the OpenFF Toolkit produces partial charges that do not depend on the input conformation of parameterized molecules. See the FAQ for more information.
from openff.toolkit import ForceField, Molecule, Topology
ethanol = Molecule.from_smiles("CCO")
cyclohexane = Molecule.from_smiles("C1CCCCC1")
# Load the topology from a PDB file and `Molecule` objects
topology = Topology.from_pdb(
"1_cyclohexane_1_ethanol.pdb",
unique_molecules=[ethanol, cyclohexane],
)
topology
<openff.toolkit.topology.topology.Topology at 0x7f952a3ebf10>
Preparing an OpenFF ForceField
Once the ForceField
class is imported, the only decision to make is which force field to use. An exhaustive list of force fields released by the Open Force Field Initiative can be found here.
Here we will use force field from the “Sage” line.
forcefield = ForceField("openff-2.2.0.offxml")
forcefield
<openff.toolkit.typing.engines.smirnoff.forcefield.ForceField at 0x7f9564b0a260>
Preparing an OpenMM System
Once a force field and topology have been loaded, an openmm.System
can be generated natively with the OpenFF Toolkit.
omm_system = forcefield.create_openmm_system(topology)
omm_system
<openmm.openmm.System; proxy of <Swig Object of type 'OpenMM::System *' at 0x7f952910f210> >
Preparing an Interchange object
To exports to engines other than OpenMM, we will make use of the Interchange project. There is a high-level Interchange.from_smirnoff
function that consumes OpenFF Toolkit and ForceField objects and produces an Interchange
object which can then be exported to formats understood by other molecular simulation engines. This extra step is needed to provide a clean interface between applied parameters and engines. Note also that this step does not require an OpenMM System to be generated; ForceField.create_openmm_system
does not need to be called to use Amber and GROMACS.
from openff.interchange import Interchange
interchange = Interchange.from_smirnoff(
force_field=forcefield,
topology=topology,
)
interchange
Interchange with 7 collections, periodic topology with 27 atoms.
Exporting to Amber and GROMACS files
Once an Interchange
object has been constructed, its API can be used to export to files understood by GROMACS, Amber, and more.
# Export AMBER files.
interchange.to_prmtop("system.prmtop")
interchange.to_inpcrd("system.inpcrd")
# Export GROMACS files.
interchange.to_top("system.top")
interchange.to_gro("system.gro")
Validating the conversion to Amber files
The Interchange project includes functions that take in an Interchange
object and call out to simulation engines to run single-point energy calculations (with no minimization or dynamics) for the purpose of validating the export layer with each engine. Under the hood, each of these functions calls API points like those used above while converting to files understood by each engine. These rely on having each engine installed and accessible in the current $PATH
.
from openff.interchange.drivers import get_amber_energies, get_openmm_energies
openmm_energies = get_openmm_energies(interchange)
openmm_energies.energies
{'Bond': 0.7287034873632433 <Unit('kilojoule / mole')>,
'Angle': 8.660863952232454 <Unit('kilojoule / mole')>,
'Torsion': 24.825477218278905 <Unit('kilojoule / mole')>,
'Nonbonded': 2.818341523387724 <Unit('kilojoule / mole')>}
amber_energies = get_amber_energies(interchange)
amber_energies.energies
/home/runner/micromamba/envs/openff-docs-examples/lib/python3.10/site-packages/openff/interchange/components/mdconfig.py:401: SwitchingFunctionNotImplementedWarning: A switching distance 8.0 angstrom was specified by the force field, but Amber does not implement a switching function. Using a hard cut-off instead. Non-bonded interactions will be affected.
warnings.warn(
{'Bond': 0.7288528 <Unit('kilojoule / mole')>,
'Angle': 8.660879999999999 <Unit('kilojoule / mole')>,
'Torsion': 24.8253456 <Unit('kilojoule / mole')>,
'vdW': 9.6667136 <Unit('kilojoule / mole')>,
'Electrostatics': -6.84084 <Unit('kilojoule / mole')>}
Appendix: Validating the conversion to GROMACS and LAMMPS files
If GROMACS and/or LAMMPS are installed on your machine, the same comparisons can also take place with those engines. They are available via conda
by running a command like:
mamba install "gromacs >=2021=nompi*" lammps -c conda-forge
from distutils.spawn import find_executable
from pprint import pprint
from openff.interchange.drivers import get_gromacs_energies, get_lammps_energies
if find_executable("lmp_serial"):
pprint(get_lammps_energies(interchange).energies)
/tmp/ipykernel_4736/2219084587.py:1: DeprecationWarning: Use shutil.which instead of find_executable
if find_executable("lmp_serial"):
if find_executable("gmx"):
pprint(get_gromacs_energies(interchange).energies)
/tmp/ipykernel_4736/3259994373.py:1: DeprecationWarning: Use shutil.which instead of find_executable
if find_executable("gmx"):
{'Angle': <Quantity(8.66089058, 'kilojoule / mole')>,
'Bond': <Quantity(0.728675842, 'kilojoule / mole')>,
'Electrostatics': <Quantity(-6.8472662, 'kilojoule / mole')>,
'RBTorsion': <Quantity(0.0, 'kilojoule / mole')>,
'Torsion': <Quantity(24.8254776, 'kilojoule / mole')>,
'vdW': <Quantity(9.66705024, 'kilojoule / mole')>}
Finally, there is a helper function get_summary_data
that will attempt to run drivers of each engine. A summary reported is prepared as a Pandas DataFrame
.
from openff.interchange.drivers.all import get_summary_data
get_summary_data(interchange)
/home/runner/micromamba/envs/openff-docs-examples/lib/python3.10/site-packages/openff/interchange/components/mdconfig.py:401: SwitchingFunctionNotImplementedWarning: A switching distance 8.0 angstrom was specified by the force field, but Amber does not implement a switching function. Using a hard cut-off instead. Non-bonded interactions will be affected.
warnings.warn(
/home/runner/micromamba/envs/openff-docs-examples/lib/python3.10/site-packages/openff/interchange/components/mdconfig.py:277: SwitchingFunctionNotImplementedWarning: A switching distance 8.0 angstrom was specified by the force field, but LAMMPS may not implement a switching function as specified by SMIRNOFF. Using a hard cut-off instead. Non-bonded interactions will be affected.
warnings.warn(
Bond | Angle | Torsion | Electrostatics | vdW | RBTorsion | |
---|---|---|---|---|---|---|
OpenMM | 0.728703 | 8.660864 | 24.825477 | -6.840315 | 9.658657 | NaN |
Amber | 0.728853 | 8.660880 | 24.825346 | -6.840840 | 9.666714 | NaN |
GROMACS | 0.728676 | 8.660891 | 24.825478 | -6.847266 | 9.667050 | 0.0 |
LAMMPS | 0.728703 | 8.660864 | 24.825477 | -6.944297 | 9.630999 | NaN |