100% found this document useful (1 vote)
312 views46 pages

Introduction To Molecular Dynamics

Molecular Dynamics for beginners and step by step process

Uploaded by

Girinath Pillai
Copyright
© Attribution Non-Commercial (BY-NC)
We take content rights seriously. If you suspect this is your content, claim it here.
100% found this document useful (1 vote)
312 views46 pages

Introduction To Molecular Dynamics

Molecular Dynamics for beginners and step by step process

Uploaded by

Girinath Pillai
Copyright
© Attribution Non-Commercial (BY-NC)
We take content rights seriously. If you suspect this is your content, claim it here.
You are on page 1/ 46

May 25, 2020

Molecular Dynamics
Detailed Overview

Recorded presentation video is at http://www.youtube.com/giribio

Girinath G. Pillai, PhD


@giribio
Disclaimer

● Please do not share any personal details during this online


meeting.

● Slides contains contents/pictures/videos taken from web, articles,


lectures, tutorials and its respective authors own their copyrights.
References are given at Slide #46

● Slides : slideshare.net/giribio
● Video : youtube.com/giribio
● Exercise : github.com/giribio/MDNotebooks
● What is Molecular Dynamics

● How MD is performed

● Forcefields

● Steps in MD
What to expect? ● Applications of MD

● Limitations of MD

● Why computationally intensive?

● Resources

3
Molecular Dynamics
● Mimics what atoms do in real life, assuming a given potential energy function
● Analyzing the physical movements of atoms and molecules
○ The energy function allows us to calculate the force experienced by any atom given the positions of
the other atoms
○ Newton’s laws tell us how those forces will affect the motions of the atoms

● MD Simulation on simplified protein folding : Nature 253 5494: 694–698 (1975)


● MD Simulation on biological process : Nature 260 5553: 679–683 (1976)
Source:
Citation details at at Slide #46
May 25, 2020 Girinath G. Pillai, PhD 4
Key properties in MD
● In real life, and in an MD simulation, atoms are in constant motion
○ They will not go to an energy minimum and stay there.

● Given enough time, the simulation samples the Boltzmann distribution


○ That is, the probability of observing a particular arrangement of atoms is a function of the potential
energy
○ In reality, one often does not simulate long enough to reach all energetically favorable
arrangements
○ This is not the only way to explore the energy surface (i.e., sample the Boltzmann distribution), but
it’s a pretty effective way to do so
Probability distribution or probability measure that
gives the probability that a system will be in a certain
state as a function of that state's energy and the
temperature of the system

Source:
Citation details at at Slide #46
May 25, 2020 Girinath G. Pillai, PhD 5
Mechanics of MD
● Each atom (ai) is considered as particle with mass (mi) and charge (qi)
● Newton’s Second law of motion Fi = mi*a, acceleration of the atom at time t can
be calculated
second law states that the acceleration of an object is
dependent upon two variables - the net force acting upon
the object and the mass of the object.

● Velocity (v) can be calculated from acceleration (acceleration is the derivative of velocity)
● Position can be calculated from velocity (v) (velocity is the derivative of position)

● Therefore, the position of atom at time (t), where Δt can be calculated

Source:
Citation details at at Slide #46
May 25, 2020 Girinath G. Pillai, PhD 6
MD in Energy Terms
● Total energy (potential + kinetic) should be conserved
○ In atomic arrangements with lower potential energy, atoms move faster
○ In practice, total energy tends to grow slowly with time due to numerical errors (rounding errors)
○ In many simulations, one adds a mechanism to keep the temperature roughly constant (a
“thermostat”)
○ Thermostat will dampen the increase in energy over time. The surrounding atoms will absorb
energy from the system if the system increases in energy

Source:
Citation details at at Slide #46
May 25, 2020 Girinath G. Pillai, PhD 7
How MD is performed?
● A molecule (protein, DNA, RNA, etc) contains atoms, covalent bonds and
each atoms are considered as particle and bonds considered as flexible
spring
● Size of the particle can be defined by vdW radii and strength of the spring is
determined by the strength of the bond
● So, size of C will be larger than H but smaller than O and double || bonds will
smaller (stronger) than single | bond but larger (weaker) than triple ||| bond
● Electrostatic interactions plays a vital role due to high charge density on the
particles hence appropriate charges are assigned on each one of them
● Using these details, we determine potential energy from mathematical
equation and with the combination of parameters (vdW, charges, bond order,
etc). >>>>>>>. We call this as Molecular Mechanics Force Field
Source:
May 25, 2020 Girinath G. Pillai, PhD J. Am. Chem. Soc. (2015), 137, 22, 7152–7159 8
What is required to perform MD?
● 3D structure of the molecule and connectivity

● Choice of the right force field with element coverage


● vdW radii, bonding, geometry, charges, force constants, etc (parameters)
● Mathematical formula to calculate potentials and other properties
● Divide time into discrete time steps, no more than a few femtoseconds (10 –15 s)
each
Source:
Citation details at at Slide #46
May 25, 2020 Girinath G. Pillai, PhD 9
Force Field : Types of Interactions

vdW Inter V(r) = Ebonded + Enon-bonded


ac tion

d ra l
D ihe
n g le
on dA
B d i ng
Be n

d Coulomb’s
Bon hing
t re tc Interactio
S n Source:
Citation details at at Slide #46
May 25, 2020 Girinath G. Pillai, PhD 10
Force Field : Types of Interactions
Bonded Interactions Non-Bonded Interactions
● Interaction potentials rises due to ● Potential arises due to non covalent
covalent bond properties. bonded properties
● Bond stretching & angle bending can be ● Lennard-Jones & Coulomb’s Potential
described by Hooke’s law.

Source:
Citation details at at Slide #46
May 25, 2020 Girinath G. Pillai, PhD 11
List of Forcefields
● UFF (parameters for most of the elements in the periodic table)
● CFF (parameters for different organic compounds)
● MMFF94 (parameters for small molecules)
● MM2,MM3,MM4,MMX (chemical compounds)
● CHARMm (proteins, nucleic acids, lipids, small molecules)
● AMBER (proteins, nucleic acids, lipids, small molecules)
● GROMOS (proteins, nucleic acids, sugars, small molecules)
● OPLS (proteins, nucleic acids, small molecules)
Do not confuse CHARMM and AMBER force fields with CHARMM and AMBER
software packages
Source:
Citation details at at Slide #46
May 25, 2020 Girinath G. Pillai, PhD 12
Steps in MD

Preparation of the Initialization and Analysis of Trajectories,


Molecule Equilibration (NVT, NPT) RMSD, RMSF, Gyration,etc

STEP 1 STEP 2 STEP 3 STEP 4 STEP 5


STEP 1

PBC (box), Solvation, Production &


Ionization Simulation

May 25, 2020 Girinath G. Pillai, PhD 13


Initiation and Basics of MD Process

Source:
Citation details at at Slide #46
May 25, 2020 Girinath G. Pillai, PhD 14
Periodic Boundary Conditions - Box
Boundary conditions are required to control the flow of
atoms/molecules moving away from simulation system
● Central box represents the simulation system and
surrounding boxes are replica (exact copy in all details,
position, velocity, etc)
● Whenever an atom leaves the simulation cell, it is replaced by
the image which enters from the opposite cell (face of
replica) entering and keeps the number of atoms is
simulation cell conserved
● Avoids the edge effect due to movement of system during
simulation as well as molecule interacts with images in the
replica to mimic the bulk phase.
Source:
● Properties : pressure, stress, density, volume, area, etc Science 334, 517 (2011);
May 25, 2020 Girinath G. Pillai, PhD 15
Solvation
Ignoring the solvent (the molecules surrounding the molecule of
interest) leads to major artifacts
● Water, salt ions (e.g., sodium, chloride), lipids of the cell membrane
● Provides dielectric effect that affects the electrostatic interactions
for determining forces

Two options for taking solvent into account


● Implicit solvation - DDD, GB, GBMB, PBSA models
○ Mathematical model to approximate average effects of solvent
○ Solvent replaced with continuous, homogeneous, medium of bulk dielectric constants
○ Less accurate but faster
● Explicit solvation - SPC, SPC/E, TIP3P, TIP4P, TIP5P models
○ High computational expense but more accurate
○ Usually assume periodic boundary conditions
○ Actual model of solvent molecules Source:
Science 334, 517 (2011);
May 25, 2020 Girinath G. Pillai, PhD SPC&TIP3P TIP4P TIP5P 16
Ionization
● Neutralizing a system is carried out for obtaining
correct electrostatic values during the
simulation.
● Under periodic boundary and using PME
electrostatics - the system has to be NEUTRAL.
● Addition of ions means that some salt is present,
however this is not equal to saline conditions.
● If you want to simulate your system in the
presence of a salt - neutralize and achieve the
concentration of interest.
● Some proteins in real might be sensitive to the
salt concentrations, therefore ensure the
positioning of ions is acceptable in the system
prior to simulation
May 25, 2020 Girinath G. Pillai, PhD Citation details at at Slide #46 17
Minimization Equilibration
● Preparation of the system have Equilibration phase is conducted under
introduced unnatural stress, for the ensemble(s) of interest to remove
example by placing two atoms the effects of adding water, ions, and
accidentally too close to each other. whatever else around some initial solute
of interest. Or, more generally, remove
● Result in large forces acting on the
the possible artifacts of whatever
particles that would blow up the
construction is done in whatever system
system
of interest, which may be ordered (low
● To solve this problem, an energy entropy and high regularity) or totally
minimization is performed in which random and therefore of unknown reality.
the system is relaxed to the closest
Do not want the protein to move
local energy minimum.
significantly during the equilibration
phase, we will restrain it with harmonic
forces to its initial position.
May 25, 2020 Girinath G. Pillai, PhD Citation details at at Slide #46 18
Equilibration
Statistical Mechanics (Statistical Thermodynamics)
explains the thermodynamic behaviour of large systems
Microcanonical (NVE) Canonical (NVT) Isothermal–isobaric (NPT)
● changes in moles (N), volume ● amount of substance (N), ● amount of substance (N),
(V), and energy (E) volume (V) and temperature pressure (P) and temperature
(T) are conserved (T) are conserved
● Given the initial positions and
velocities, we can calculate all ● energy of endothermic and ● Close to lab conditions with
future (or past) positions and exothermic processes is ambient temperature and
velocities. exchanged with a pressure
thermostat
NVE is to increase the temperature, and then NPT for production simulation. NVE is not at
equilibrium. Check the temperature, pressure, density and total energy. If all are stable, it might be at
equilibrium state. In most simulations, the system will change a lot in NVE and first period of NPT,
and then becomes stable
May 25, 2020 Girinath G. Pillai, PhD Citation details at at Slide #46 19
Production MD or Simulation
● Unrestrained production MD simulation,
○ Nose-Hoover thermostat and Parrinello-Rahman barostat was used that they more accurately
sample the isothermal-isobaric ensemble.
■ Did not use them for equilibration as they introduce large oscillations around their target
values (T and p) if the system starts far away from equilibrium.

● Goal of most typical simulations is actually to have equilibrium sampling during


production (data collection or generate trajectories).

May 25, 2020 Girinath G. Pillai, PhD Citation details at at Slide #46 20
Parameters - MD Simulation
● Simulation size (n = number of particles), timestep, and total time duration must
be selected so that the calculation can finish within a reasonable time period
● Ensembles - NVT, NPT, NVE
● Temperature, Pressure
● Thermostat : Velocity rescaling/
● Barostat : Langevin/MTK
● Restraints and Constraints : SHAKES
● Short Range and Long Range Electrostatics : PME
● Time Step (fs, ns, ps) > Duration of MD Run (Time Step x No. of steps)
● MD Integrator : VERLET (to integrate Newton’s equation of motions, 1791 Delmabre)
Source:
Citation details at at Slide #46
May 25, 2020 Girinath G. Pillai, PhD J. Am. Chem. Soc. (2015), 137, 22, 7152–7159 21
MD Trajectories
1. Temperature, Pressure, Volume
2. Energy (potential, kinetic, total)
3. RMS Deviation (RMSD)
Main output from a MD Simulation and it 4. RMS Fluctuation (RMSF)
contains coordinates, velocities and
5. Secondary Structure Analysis
energy of all conformations generated
during MD. 6. Radius of Gyration
7. Hydrogen Bond Analysis
8. Covariance & PCA
9. Protein-Ligand Interactions
Source:
Citation details at at Slide #46 10. Free Energy Surfaces
May 25, 2020 Girinath G. Pillai, PhD 22
Hierarchy of principal motion and duration for MD
Source: Science 334, 517 (2011);
bond vibrations J. Am. Chem. Soc. (2015), 137, 22, 7152–7159
(fs–ps) 10-15 fs Bond Stretching
Bond stretching interactions it is helpful to consider
side-chain rotations 1Gf how the energy of a bond changes with its length.
(ps–ns)
10-12 ps Stretching Vibrations
Symmetric stretching, two or more bonds vibrate in and out
1Tf together. asymmetric stretching, some bonds are getting shorter
backbone
fluctuations (ns),
10-9 ns Hinge Bending
Bending is the variation of the angle of the bond caused by a
vibration
10Tf
loop motion/gating
(ns–ms) 10-6 µs ɑ-Helix folding
A common motif in the secondary structure of proteins and is a
ligand binding/ 100Tf right hand-helix conformation in which every backbone N−H
group hydrogen bonds to the backbone C=O
unbinding events
(>100 ns) 10-3 ms β-Hairpin folding
A simple protein structural motif involving two beta strands that
1Pf look like a hairpin
collective domain
movement (>µs)
100 s Large Protein folding
a polypeptide chain folds to become a biologically active protein
in its native 3D structure. Protein structure is crucial to its
May 25, 2020 Girinath G. Pillai, PhD function.
Citation details at at Slide #46 23
Why is MD computationally demanding?
● Many time steps (millions to trillions)

● Substantial amount of computation at every time step


○ Dominated by non-bonded interactions, as these act between every pair of atoms.
○ In a system of N atoms, the number of non-bonded terms is proportional to N2

● Can we ignore interactions beyond atoms separated by more than some fixed
cutoff distance?
○ For van der Waals interactions, yes. These forces fall off quickly with distance.
○ For electrostatics, no. These forces fall off slowly with distance.
Source:
Citation details at at Slide #46
May 25, 2020 Girinath G. Pillai, PhD 24
How to speed up MD Simulations?
● Reduce the amount of computation per time step
○ fast approximate methods to compute electrostatic interactions, or methods that allow you to
evaluate some force field terms every other time step.
● Reduce the number of time steps required to simulate a certain amount of
physical time
○ One can increase the time step several fold by freezing out some very fast motions (e.g., certain
bond lengths).
● Reduce the amount of physical time that must be simulated
○ A major research area involves making events of interest take place more quickly in simulation, or
making the simulation reach all low-energy conformational states more quickly.
○ For example, one might apply artificial forces to pull a drug molecule off a protein, or push the
simulation away from states it has already visited.
○ Each of these methods is effective in certain specific cases.
● Parallelize the simulation across multiple computers
○ Usually each processor takes responsibility for atoms in one spatial region.
○ Algorithmic improvements can reduce communication requirements.
● Redesign computer CPU or GPU to make this computation run faster Source:
Citation details at at Slide #46
May 25, 2020 Girinath G. Pillai, PhD 25
Applications of MD
Kinetic Properties Thermodynamic Properties
- time based evolutions of conformations - based on intermolecular interactions

● Refinement of Protein structure & ● Free Energy of Binding


complex
● FEP
● Stability of Protein Structure
● Poisson–Boltzmann or Generalized
● Conformational sampling of small Born and Surface Area continuum
molecules solvation (MM/PBSA and
MM/GBSA)
● Protein folding
● Heat of vaporization
● Stability of protein-ligand interactions
● Pressure
● Transport of ions & ligands
● Boiling point Source:
Citation details at at Slide #46
May 25, 2020 Girinath G. Pillai, PhD 26
Where does drug bind and are they stable?
Simulations were used to determine where the
molecule binds to its receptor, and how it changes
the binding strength of molecules that bind
elsewhere (in part by changing the protein’s
structure).

Used the information


to modify the
molecule such
that it has a
enriched effect.

Source:
Science 334, 517 (2011);
J. Am. Chem. Soc. (2015), 137, 22, 7152–7159

May 25, 2020 Girinath G. Pillai, PhD Citation details at at Slide #46 27
Mechanisms of Protein Allostery with MD Simulations
● Bidirectionality and the principle of microscopic
reversibility
● Structural basis for allosteric modulation of a GPCR
● Mechanism of GPCR activation
● Mechanism of nucleotide release in heterotrimeric G
proteins
● Mechanosensitive interaction between bacterial
adhesins and fibronectin

Source:
PLOS Computational Biology 12(6): e1004746
Int. J. Mol. Sci. 2020, 21, 847
PLOS Computational Biology 12(6): e1004966

May 25, 2020 Girinath G. Pillai, PhD 28


Functional mechanism
● Simulations were performed in MD Simulation on Na+ ion channels
which a receptor protein transitions
spontaneously from its active
structure to its inactive structure

● Used the MD information to explain


the mechanism by which drugs
binding to one end of the receptor
cause the other end of the receptor
to change shape (activate)

Source:
Citation details at at Slide #46
May 25, 2020 Girinath G. Pillai, PhD 29
Process of protein folding

For example, in what order do


secondary structure elements form?
But note that short MD is generally
not the best way to predict the folded
structure

Source:
Simulation of millisecond protein folding: NTL9 (from Folding@home)
Science 334, 517 (2011);
May 25, 2020 Girinath G. Pillai, PhD J. Am. Chem. Soc. (2015), 137, 22, 7152–7159 30
MD Simulation - A snapshot

Complete molecular dynamics


simulation steps on higher
timescale.

Source:
Citation details at at Slide #46

May 25, 2020 Girinath G. Pillai, PhD 31


Timescales Limitations of MD
● Simulations require short time steps for numerical stability
■ 1 time step ≈ 2 fs (2×10–15 s)
■ 2fs x 1,00,00,000 steps = 2,00,00,000fs = 20,000ps = 20ns
● Structural changes in proteins can take ns(10–9s), µs(10–6s), ms(10–3s), or longer
■ Millions to trillions of sequential time steps for nanosecond to millisecond events (and even
more for slower ones)

● Until recently, simulations of 1 µs were rare


● Advances in computer power have enabled µs simulations, but simulation
timescales remain a challenge
● Enabling longer-timescale simulations is an active research area, involving:
■ Algorithmic improvements
■ Parallel computing
■ Hardware: GPUs, specialized hardware
Source:
Citation details at at Slide #46
May 25, 2020 Girinath G. Pillai, PhD 32
Forcefield Accuracy Limitations of MD
● Molecular mechanics force fields are Here force fields with lower scores are
inherently approximations better, as assessed by agreement
● They have improved substantially over the between simulations and experimental
data. Even the force fields with scores of
last decade, but many limitations remain zero are imperfect, however!

● In practice, one needs some experience to


know what to trust in a simulation

Source:
Science 334, 517 (2011);
May 25, 2020 Girinath G. Pillai, PhD PLoS ONE 7(2): e32131 33
Bond formation/breakage Limitations of MD
● Once a protein is created, most of its covalent bonds do not break or form during
typical function
● A few covalent bonds do form and break more frequently (in real life)
■ – Disulfide bonds between cysteines
■ – Acidic or basic amino acid residues can lose or gain a hydrogen (i.e., a proton)

● Limitations of certain forcefields


○ low temperatures are not well described
○ tunneling of hydrogens are not described
○ heat capacity is considered wrong
○ chemical reactions are not described
○ high-frequency vibrations are inaccurate
○ electronic polarization are described implicitly
Source:
Citation details at at Slide #46
May 25, 2020 Girinath G. Pillai, PhD 34
Specialized MD
● Simulated Annealing
○ MD performed at different temperatures for a fixed duration in a single run using a thermostat
○ Avoid the chance of molecule blocked at local energy minima, (conformational potential energy barrier)

● Targeted MD (TMD)
○ Explore conformational path between initial and final conformation of a molecule.
○ Opening and closing of ion channels or transporters or large movement of domains in kinases

● Steered MD (SMD)
○ Similar to TMD but using a pulling force.
○ Study the mechanism of association/dissociation of ligand with receptor

● Replica Exchange MD (REMD)


○ Combination of MD with the Monte Carlo, this method is capable of overcoming high energy-barriers
easily and sampling conformational space of proteins

● Langevin Dynamics - a stochastic differential equation, two force terms, neglected DOF
Source:
● Brownian Dynamics- simplified version of LD Citation details at at Slide #46
May 25, 2020 Girinath G. Pillai, PhD 35
Resources
All are free to use for academic purpose

36
Software for MD
Macromolecules, Biomolecules & Small molecules
AMBER - Assisted Model Building with Energy Refinement
GROMACS - GROningen MAchine for Chemical Simulations
NAMD - Nanoscale Molecular Dynamics
CHARMM - Chemistry at Harvard Macromolecular Mechanics
DESMOND

Solid State & Materials


LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator

May 25, 2020 Girinath G. Pillai, PhD 37


GROMACS Software
http://www.gromacs.org/
Go to Download
5.1.4v preferred for Pro-Lig
2020.2v preferred for GPU
Linux 64bit and MacOSX 64bit
extract and compile the package

For Windows 64bit


Use Cygwin and Gromacs :
https://winmostar.com/en/
download/cygwinwm/ Source:
Citation details at at Slide #46

May 25, 2020 Girinath G. Pillai, PhD 38


NAMD Software
https://www.ks.uiuc.edu/Research/namd/
Go to Download binaries >
Win, Linux, MacOSX 64bit > just extract and run the software along with VMD

May 25, 2020 Girinath G. Pillai, PhD 39


AMBER Software
http://ambermd.org/ Go to Download Amber, extract and compile the package

May 25, 2020 Girinath G. Pillai, PhD 40


Desmond Software
https://www.deshawresearch.com/ Go to Resources > Download 2018v for CPUs
Only Linux 64bit. Download 2019v+ for GPUs only

May 25, 2020 Girinath G. Pillai, PhD 41


Presentation Slides - SlideShare

slideshare.net/giribio
May 25, 2020 Girinath G. Pillai, PhD 42
Protein in Water - GROMACS Notebook

github.com/giribio >>> Go to MDNotebooks


doi.org/10.5281/zenodo.3832358
May 25, 2020 Girinath G. Pillai, PhD 43
Jupyter Notebook

Live demo : youtube.com/giribio

May 25, 2020 Girinath G. Pillai, PhD 44


Thank you!
Follow-up session will scheduled for a You could execute the Jupyter Notebook in my
walkthrough on running MD simulation using GitHub and run short MD simulation on 1AKI.pdb
GROMACS. and you could send submit you queries or data
links to

https://github.com/giribio/MDNotebooks/issues

@giribio
45
Content Sources
References Web Sources
● PNAS 2011 108 (46) 18684-18689 ● sciencesprings.wordpress.com/
● Nature 2009; 459(7245):356-63 ● Theislikerice, en.wikipedia.org/wiki/Alpha_helix
● Nature 03, 295–299(2013) ● Tiago Becerra Paolini,
● Scientific Reports 6,: 23830 (2016) en.wikipedia.org/wiki/Molecular_vibratio
● J. Chem. Theory Comput. 2017, 13, 7, 3348–3358 ● dynamicscience.com.au/
● Solvation Model for Theoretical Chemistry, Waldemar Kulig ● cmm.cit.nih.gov/intro_simulation
● Int. J. Mol. Sci. 2020, 21(8), 2713 ● BQUB19 AAbad, commons.wikimedia.org/
● PLOS Computational Biology 9(5): e1003058 ● i12r-studfilesrv.informatik.tu-muenchen.de/
● Methods Mol Biol 2018;1777:101-119 ● en.wikipedia.org/wiki
● researchgate.net
● Online lecture contents from Stanford, UCLA, Harvard,
NPTEL, Patshala, universities

May 25, 2020 Girinath G. Pillai, PhD 46

You might also like