Running a PyRETIS simulation with OpenMMΒΆ

In this example we will show the interface between OpenMM and PyRETIS. The implementation, so far, only exists as a library. So instead of using the standard PyRETIS input files, this example will consist of python scripts. They will import PyRETIS and OpenMM objects and use them directly.

First we will have to generate an OpenMM Simulation object. We use the online tool OpenMM Script Builder to generate the example pdb of 2 water molecules.

##########################################################################
# this script was generated by openmm-builder. to customize it further,
# you can save the file to disk and edit it with your favorite editor.
##########################################################################

from openmm import app
import openmm as mm
from openmm import unit

pdb = app.PDBFile('input.pdb')
forcefield = app.ForceField('amber99sbildn.xml', 'tip3p.xml')

system = forcefield.createSystem(pdb.topology, nonbondedMethod=app.PME,
                                 nonbondedCutoff=1.0*unit.nanometers,
                                 constraints=app.HBonds, rigidWater=True,
                                 ewaldErrorTolerance=0.0005)
integrator = mm.LangevinIntegrator(300*unit.kelvin,
                                   1.0/unit.picoseconds,
                                   2.0*unit.femtoseconds)
integrator.setConstraintTolerance(0.00001)
platform = mm.Platform.getPlatformByName('CPU')
simulation = app.Simulation(pdb.topology, system, integrator, platform)
simulation.context.setPositions(pdb.positions)

With this Simulation object we can now construct the internal PyRETIS system and OpenMMEngine objects

import openmm.unit as u
from pyretis.core import System, Particles
from pyretis.core.box import create_box, box_matrix_to_list
from pyretis.engines import OpenMMEngine

def make_pyretis_system(simulation):
    """Makes PyRETIS system from OpenMM Simulation."""
    state = simulation.context.getState(getPositions=True, getVelocities=True)
    box = state.getPeriodicBoxVectors(asNumpy=True).T
    box = create_box(cell=box_matrix_to_list(box),
                     periodic=[True, True, True])
    system = System(units='gromacs', box=box,
                    temperature=simulation.integrator.getTemperature())
    system.particles = Particles(system.get_dim())
    pos = state.getPositions(asNumpy=True)
    vel = state.getVelocities(asNumpy=True)
    for i, atom in enumerate(simulation.topology.atoms()):
        mass = simulation.system.getParticleMass(i)
        mass = mass.value_in_unit(u.grams/u.mole)
        name = atom.name
        system.particles.add_particle(pos=pos[i], vel=vel[i],
                                      force=[None, None, None],
                                      mass=mass, name=name)
    return system

# Make system and initialise the engine.
system = make_pyretis_system(simulation=simulation)
engine = OpenMMEngine(simulation=simulation)

From this point we use this altered rst to set up the rest of the RETIS simulation.

# Load the settings
from pyretis.inout.settings import parse_settings_file
from pyretis.inout.setup import create_simulation
settings = parse_settings_file('openmm_retis.rst')

# Now we need to override some things due to pyretis internals
def mock_potential_and_force():
    pass

system.potential_and_force = mock_potential_and_force # Not used, but legacy requirement
engine.engine_type = 'internal' # was OpenMM

kwargs = {"system": system,
          "engine": engine}
pyretis_simulation = create_simulation(settings=settings, kwargs=kwargs)

Now that we have set up the pyretis_simulation, we can setup the outputs, initiate the ensmebles and run it. (Make sure you have write permisions in the running directory)

# If the default output colors are too flamboyant you can reset the colors
# import colorama
# colorama.init(autoreset=True)

# Setup the outputs
pyretis_simulation.set_up_output(settings=settings)

# Initiate the simulation
pyretis_simulation.initiate(settings=settings)

# Run through the simulation generator to run the simulation
for step in pyretis_simulation.run():
    pass