First SimulationΒΆ
This is a good starting point for learning how to use OpenMM.
It loads a PDB file villin.pdb, which is the villin headpiece protein in a box of water. In then parameterizes it using the Amber14 forcefield and TIP3P-FB water model, energy minimizes it, and simulates it for 1000 steps with a langevin intergator.
[1]:
from openmm.app import *
from openmm import *
from openmm.unit import *
from sys import stdout
# Load in the PDB strucure
pdb = PDBFile('villin.pdb')
# Specifiy the forcefield
forcefield = ForceField('amber14-all.xml', 'amber14/tip3pfb.xml')
# Combine the molecular topology and the forcefield
system = forcefield.createSystem(pdb.topology, nonbondedMethod=PME,
nonbondedCutoff=1*nanometer, constraints=HBonds)
# Create the integrator to use for advacing the equations of motion.
# It specifies a Langevin integrator.
# The paramters set are temperature, friction coefficient, and timestep.
integrator = LangevinMiddleIntegrator(300*kelvin, 1/picosecond, 0.004*picoseconds)
# Combines the molecular topology, system, and integrator
# to begin a new simulation.
simulation = Simulation(pdb.topology, system, integrator)
simulation.context.setPositions(pdb.positions)
# Perform local energy minimization
print("Minimizing energy...")
simulation.minimizeEnergy(maxIterations=100)
# Write the trajectory to a file called "output.pdb"
simulation.reporters.append(PDBReporter('output.pdb', 1000))
# Report infomation to the screen as the simulation runs
simulation.reporters.append(StateDataReporter(stdout, 100, step=True,
potentialEnergy=True, temperature=True))
#Run the simulation for 1000 timsteps
print("Running simulation...")
simulation.step(1000)
Minimizing energy...
Running simulation...
#"Step","Potential Energy (kJ/mole)","Temperature (K)"
100,-154093.673759413,147.41188300614368
200,-150765.74905254936,197.86551155815224
300,-148557.58199204956,231.37476634270453
400,-146572.26045897018,253.3845842583678
500,-145394.73735348118,271.7445596202129
600,-144132.99165580928,275.55382480771993
700,-144067.05831415133,289.1695312327078
800,-143281.30071492956,290.9185112620418
900,-142911.56524813268,294.09901146763957
1000,-142245.25343048433,293.29483369367676