49
Analysis of MD trajectories in GROMACS David van der Spoel

Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

  • Upload
    lybao

  • View
    236

  • Download
    2

Embed Size (px)

Citation preview

Page 1: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Analysis of MD trajectories in

GROMACSDavid van der Spoel

Page 2: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

What does MD produce?

Energy terms E(t)

Coordinates x(t)

Velocities v(t)

Forces f(t)

Page 3: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Managing your filestrjcat - merging trajectories

concatenatingdemultiplexing REMD

trjconv - converting trajectoriesscaling, translating, rotatingperiodic boundary conditionsleast squares superposition

eneconv - merging and converting energy files

Page 4: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Viewing your trajectory

ngmx - part of GROMACS

VMD - http://www.ks.uiuc.edu

gOpenMol - http://www.csc.fi/gopenmol

pymol - http://pymol.sf.net

Page 5: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Dynamics = Movies

Page 6: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Quantifying DynamicsEinstein relation:

g_msd - Mean Square Displacement and diffusion constants

Green-Kubo relation:

g_velacc - Velocity Autocorrelation Function

6Dt = limt!"

(r ! r0)2

3D =

!!

0

v(t) · v(0)dt

Page 7: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,
Page 8: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Liquid Structure

g_rdf - Radial Distribution Function gives the local density of species B around species A relative to the average density

gAB(r) =!B(r)

!!B"=

1

NA !!B"

NA!

i!A

NB!

j!B

"(rij # r)

4#r2

Page 9: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,
Page 10: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Forces between “particles”

Page 11: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

30 Mass% Methanol solution between quartz particles

Page 12: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Integrated force until infinity yields Helmholtz energy

Page 13: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Using forces ctd.

Using the forces directly from MD is not very accurate due to large fluctuations

Other methods to compute potential of mean force (PMF) are implemented in GROMACS:

Atomic Force Microscopy (AFM) Pulling, where you gently pull on a molecule

Umbrella sampling

Page 14: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Hydrogen Bonds

Can be defined using either geometrical or energetic criterion

g_hbond - geometric criterion onlyr < rHB (typically 0.35 nm)

alpha < alphaHB (typically 30 degrees)

Page 15: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Hydrogen Bonds in Water

Page 16: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,
Page 17: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

< # HB in Ubiquitin >

PP: 56 (3)

PS: 180 (6)

SS: 10180 (30)

PP+0.5PS: 147 (4)

Page 18: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

HB Kinetics

Define a binary function Hi(t)

Hi(0) = 1

Hi(t) = 1 when hydrogen bond i exists

Hi(t) = 0 when hydrogen bond i does not exist

Compute the autocorrelation function Ci(t) = <Hi(0)Hi(t)>

Page 19: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,
Page 20: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

HB Kinetics

Define rate equation:

Compute C(t), N(t) from simulation

Numerically differentiate C(t)

Numerically solve for k and k’

Hydrogen bond life time

dC(t)

dt= kC(t) ! k

!N(t)

!HB = 1/k

Page 21: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

HB Thermodynamics

Eyring process:

Compute DG at different temperatures

Extract DH from Arrhenius equation:

!HB =h

kBTexp

!

!G‡

kBT

"

k = Aexp!EA/kBT

Page 22: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

HB Thermodynamics

Page 23: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Surface AreaA number of algorithms have been published

Connolly surfaceMSMS (Scripps)Double Cube Lattice Method (NSC, EMBL-Heidelberg)more...

g_sas uses NSC

Solvent Accessible Surface Area (SASA) often used as descriptor for e.g. computing !Gsolv

Page 24: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Double Cube Lattice Method

Map triangles on the surface of an atom (sphere)

Connect the triangles between different atoms

Compute surface area by summing triangle areas

Eisenhaber et al. JCC 16, p. 273 (1995)

Page 25: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,
Page 26: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Surface Representations

Ubiquitin surfaces created with PyMol

Page 27: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Radius of GyrationA measure of the size of a molecule

Can in principle be determined experimentally, but not very accurately

g_gyrate can align the molecule along its primary axes before computing the radius of gyration

Rg =

!

"

i mi (ri ! rcm)2"

i mi

#1/2

Page 28: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,
Page 29: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Root Mean Square Deviation

Measure of how related structures are

RMSD: requires LSQ superposition of molecules

Page 30: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

LSQ Superposition

Minimize

Where M is a six-dimensional matrix describing rotation and translation

Problematic when molecules are very different

Advantage is that this is a well-known quantity

!2 =

!

i

(rrefi ! Mri)

2

Page 31: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

RMSD

Alternative: distance based RMSD

RMSD =

!

"

i mi(rrefi ! Mri)2

"

i mi

#1/2

RMSD =1

N

!

"

N#

i

N#

j

(rrefij ! rij)

2

$

%

1/2

Page 32: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,
Page 33: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Clustering

How many different conformations are there in a simulation trajectory?

Clustering algorithms can give an answer

g_cluster implements a number of popular algorithms, all of which have their own issues

Compare RMSD between pairs of structuresGroup structures that have relatively low RMSD w.r.t. each other

Page 34: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

7000 7500 8000 8500 9000 9500 10000

7000

7500

8000

8500

9000

9500

10000

Tim

e (

ps)

Time (ps)

RMS Deviation / Cluster Index

0 RMSD (nm) 0.186

Page 35: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Secondary Structure

Very important indicator of protein structure

DSSP: dictionary of secondary structure in proteins (Kabsch & Sander, Biopolymers 22, p. 2577 (1983)), based on backbone torsion angles and hydrogen bonds

do_dssp computes SS from trajectories by executing an external DSSP program (http://swift.cmbi.ru.nl/gv/dssp/)

Page 36: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

0 2000 4000 6000 8000 10000

10

20

30

40

50

60

70

Resid

ue

Time (ps)

Secondary structure

Coil B-Sheet B-Bridge Bend Turn A-Helix 3-Helix

Page 37: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Ramachandran plot

Shows correlation of backbone angles Phi & Psi

Certain areas are energetically unfavorable (“disallowed”)

Secondary structure (Alpha helix, Beta sheet) have common backbone angles

g_rama computes them

Page 38: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Beta region

Alpha region

Page 39: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Example Ramachandran

Page 40: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Protein Dynamics

Consider a protein in solution

The protein has an overall rigid motion: rotation+translation

Within the protein secondary structure elements will be relatively rigid, but may fluctuate collectively

Within secondary structure elements atoms will fluctuate mainly about their average positions

Page 41: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

NMR Relaxation

NMR can be used to probe the intramolecular dynamics in e.g. proteins

Result is an average over long time and many molecules

Q: how long is long and how many is many?

Observables from NMR experiments can often be derived from MD simulations

Page 42: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

NH Bond-Vector RelaxationIf we disregard the overall motion of the protein we can write the motion of a distance vectors as:

Bond vectors in MD are usually rigid

It is relatively easy to study NH bond vectors in NMR using 15N labeled protein

C(t) =

!

P2 (rij(0) · rij(t))

r3ij(0) r3

ij(t)

"

Page 43: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,
Page 44: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Lipari & Szabo Analysis

Motion at long time can be described by an order parameter

S2 = 0 : motion unrestricted

S2 > 0 : motion restricted

Approximation:

C(!) = S2!

r!6

ij

"

C(t) =!

r!6

ij

"

"#

i=0

aie!t/!i

!0 = !

C(0) =!

r6

ij

"

Page 45: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,
Page 46: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Summary I

Many different tools available

Protein analysis

Liquid analysis

Dynamics

Electrostatic properties

Page 47: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Tips

Think before you perform a simulation what kind of information you would like to get out

Check availability of experimental structures and other data (e.g. energies, dynamic properties)

Page 48: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

Acknowledgements

Alexandra Patriksson, Erik Marklund for Ubiquitin simulations and analyses

Csaba Hetenyi for Ramachandran plots and the idea for this lecture

The GROMACS team for writing and correcting the GROMACS manual

Page 49: Analysis of MD trajectories in GROMACS · PDF fileManaging your files trjcat - merging trajectories concatenating demultiplexing REMD trjconv - converting trajectories scaling, translating,

GROMACSGroningen Machine for Chemical Simulations

USER MANUALVersion 3.3

but wait, there’s more...