Computational Chemistry - MD Simulations

Size: px
Start display at page:

Download "Computational Chemistry - MD Simulations"

Transcription

1 Computational Chemistry - MD Simulations P. Ojeda-May pedro.ojeda-may@umu.se Department of Chemistry/HPC2N, Umeå University, , Sweden. May 2, 2017

2 Table of contents 1 Basics on MD simulations Accelerated MD Umbrella sampling String method Coarse graining Alchemical method 2 Setting up the system, minimization, solvation, equilibration, production and analysis.

3 Simulations time scale Figure : Accuracy w.r.t. time scale for different modeling approaches.

4 Early MD simulations Figure : Nature, 253 (1975).

5 Current MD simulations Figure : Source:

6 Current MD simulations

7 Application of MD Proteins Clays Figure : Clay [JPC C, 118, 1001 (2014)]. Figure : AdK enzyme in water.

8 Application of MD Figure : Ice cream research.

9 Application of MD Figure : Asphalt research. Figure : Asphalt [Const. Build. Mat., 121, 246 (2016)].

10 Newton s equation F = U Newton s Law(1687) (1) solution of this equation requires the knowledge of an array of particles positions and velocities X = (x 1 1, x 1 2, x 1 3, x 2 1, x 2 2, x x N 1, x N 2, x N 3 ) (2) V = (v 1 1, v 1 2, v 1 3, v 2 1, v 2 2, v v N 1, v N 2, v N 3 ) (3)

11 s Figure : Source:

12 s U = bonds k bonds(r r 0 ) 2 + torsions i<j Coulomb angles V j (1 + cosjφ) j q i q j r ij + i<j VdW 1 2 k angle(θ θ 0 ) 2 { [ (σij ) 12 4ɛ ij r ij ( σij r ij ) 6 ]} (4)

13 s Figure : Energy terms. Source: (chemistry)

14 s Figure : FF for proteins comparison, PLoS ONE, 7, e32131, (2012).

15 s: Energy surface Figure : Energy surface described by U = sin(x) cos(x)

16 s Proteins and Hydrocarbons: GROMOS, OPLS-AA, AMBER, CHARMM. Clays: CLAYFF Coarse-graining: MARTINI If the parameters of your compound are not part of the force field you need to use QM approaches.

17 Water models Figure : 3-5 sites water models. Source: models.html

18 Water models Figure : See for details: JPC A, 105, 9954 (2001).

19 Protein systems Figure : 20 natural amino acids. Source: goo.gl/yryvwv

20 Protein systems Figure : PDB information of AdK. Figure : Structure of yeast AdK.

21 Periodic boundary conditions (PBC) The systems we can study with MD simulations are tiny compared to real experimental setups (10 23 particles). Figure : PBCs and minimum image convention [Allen & Tildesley, Comp. Sim. of Liquids]

22 Electrostatic interactions: Ewald method The elecrostatic energy for a periodic system can be written as 1, E = 1 2 N m Z 3 i,j=1 q i q j r ij + ml where r ij = r i r j, m refers to the periodic images. Primed summation means i = j interaction is excluded for m = 0. q x is the partial charge on atom x. (5) 1 Adv. Polym. Sci., 185, 59 (2005)

23 Electrostatic interactions: Ewald method The elecrostatic energy for a periodic system can be written as 1, E = 1 2 N m Z 3 i,j=1 q i q j r ij + ml where r ij = r i r j, m refers to the periodic images. Primed summation means i = j interaction is excluded for m = 0. q x is the partial charge on atom x. The potential is splitted such that, 1 r = f (r) + 1 f (r) r r (5) (6) 1 Adv. Polym. Sci., 185, 59 (2005)

24 Electrostatic interactions: Ewald method The elecrostatic energy for a periodic system can be written as 1, E = 1 2 N m Z 3 i,j=1 q i q j r ij + ml where r ij = r i r j, m refers to the periodic images. Primed summation means i = j interaction is excluded for m = 0. q x is the partial charge on atom x. givig rise to the total energy: (5) E = E (r) + E (k) + E (s) + E (d) (6) 1 Adv. Polym. Sci., 185, 59 (2005)

25 Electrostatic interactions E (r) = 1 2 N m Z 3 i,j=1 E (k) = 1 2V k 0 q i q j erfc(α r ij + ml ) r ij + ml (7) 4π k 2 ek2 /4α 2 ρ(k) 2 (8) E (s) = α q 2 π i (9) E (d) 2π = (1 + 2ɛ )V ( i i q i r i ) 2 (10)

26 Integration of Newton s equation We now now the force field and we know the law of motion: F = ma = U Newton s Law (11) we need to integrate this equation, here we use the leap-frog scheme [Hockney, 1970], r(t + δt) = r(t) + δtv(t + 1 δt) (12) 2 v(t δt) = v(t 1 δt) + δta (13) 2 velocities are updated according to, v(t) = 1 (v(t δt) + v(t 12 ) δt) (14)

27 Constraints Collision of two diatomic molecules Figure : Free collision. Figure : SHAKE constraint. See JCP, 112, 7919 (2000)

28 Constraints Modern approaches to deal with constraints Figure : ILVES method. See JCC, 32, 3039 (2011)

29 Techniques to speedup simulations MPI parallelization MPI+OpenMP parallelization Domain decomposition scheme Multiple communicators Figure : Nodes (MPI). do i=1,num_particles x(i) = x(i) + f(i)*dt enddo Figure : NUMA machine (OpenMP).

30 Ergodicity A obs = < A > time =< A(Γ(t)) > time = lim t obs tobs 0 A(Γ(t))dt (15) Figure : Coffee cup.

31 Statistical ensembles Microcanonical ensemble (NVE) partition function is [Allen & Tildesley, Comp. Sim. of Liquids], Q NVE = 1 1 drdpδ(h(r, p) E) (16) N! h 3N The thermodynamic potential is the negative of the entropy S/k B = ln Q NVE In the case of the Canonical ensemble (NVT) the partition function is, Q NVT = 1 1 drdp exp( H(r, p)/k B T ) (17) N! h 3N with thermodynamic potential A/k B T = ln Q NVT.

32 Statistical ensembles Isothermal-isobaric ensemble (NPT) partition function is, Q NPT = N! h 3N dv drdp exp( (H(r, p)+pv )/k B T ) V 0 (18) the corresponding thermodynamic potential is G/k B = ln Q NPT Grand-canonical ensemble (µvt) partition function is, Q µvt = 1 1 N! h 3N exp(µn/k BT ) drdp exp( H(r, p)/k B T ) N (19) the corresponding thermodynamic potential is PV /k B = ln Q µvt

33 Thermostats NVE is obtained by solving NE. NVT can be achieved with the following thermostats: Berendsen, Velocity-rescaling, Nose-Hoover. H = N i=1 p i 2m i + U(r 1, r 2,..., r N ) + p2 ξ 2Q + N f kt ξ (20) A better approach is Nose-Hoover chain. Using general and local thermostats. NPT can be simulated with Berendsen and Parrinello-Rahman methods.

34 Accelerated MD simulations The original potential energy surface V (r) is modified according to, V (r) = { V (r), V (r) E, V (r) + V (r) V (r) < E. (21) Figure : Modified potential energy surface [JCP, 120, (2004)].

35 Accelerated MD simulations the biasing term is, V (r) = (E V (r))2 α + (E V (r)) (22) Figure : Free energy landscape of Alanine dipeptide [JCP, 120, (2004)].

36 Umbrella sampling (US) simulations The potential energy is modified as follows JCP, 23, 187 (1977): E b (r) = E u (r) + w i (ξ) with w i (ξ) = K/2(ξ ξ ref i ) 2 Figure : Potential energy surface. For each window the free energy is given by, A i (ξ) = (1/β) ln P b i (ξ) w i (ξ)+f i Figure : Probability histograms.

37 String method (SM) simulations Define a set of collective variables z j and effective forces as follows k T T 0 (z j θ j (t))dt F (z) z j The free energy along the string is computed by PRB, 66, (2002), Figure : Free energy surface. F (z(α)) F (z(0)) = α 0 N i=1 dz i (α ) dα F (z(α )) z i dα

38 String method (SM) simulations Figure : Free energy surface of Alanine dipeptide.

39 Coarse-grain simulations Figure : Reduction of the degrees of freedom [Annu. Rev. Biophys., 42, 73 (2013)].

40 Coarse-grain simulations Figure : Reduction of the degrees of freedom [Annu. Rev. Biophys., 42, 73 (2013)].

41 Alchemical simulations Figure : Thermodynamic cycle for binding of two protein ligands L 1 and L 2, [JCC, 30, 1692 (2009)]. G bind L i L j = G bind L j G bind L i The Hamiltonian is modified according to, = G prot RL i RL j G solv L i L j (23) H = T x + (1 λ)v 0 + λv 1 (24)

42 Alchemical simulations Figure : Thermodynamic cycle for binding of two protein ligands L 1 and L 2, [JCC, 30, 1692 (2009)]. The free energy difference going from λ = 0 to λ = 1 is, 1 G λ=0 λ=1 = 1 β ln exp ( β(h (λ+δλ) H (λ) ) ) (25) λ=0

43 Setting up the system, minimization, solvation, equilibration, produ Installing CHARMM on Kebnekaise Load the modules module load GCC/ OpenMPI/ go to the charmm folder and type:./install.com gnu M at the end of the installation one gets the message: install.com> CHARMM Installation is completed. The CHARMM executable is /pfs/nobackup/home/

44 mpirun -np 28 /home/u/user/pfs/charmm_tutorial/charmm/exec/ -i step4_equilibration.inp > out_equilibration.dat mpirun -np 28 /home/u/user/pfs/charmm_tutorial/charmm/exec/ P. cnt=1 Ojeda-May -i step5_production.inp Computational > out_production.dat Chemistry - MD Simulations Basics on MD simulations Setting up the system, minimization, solvation, equilibration, produ Running CHARMM on Kebnekaise #!/bin/bash #SBATCH -A project-id #SBATCH -N 1 #SBATCH --time=01:00:00 #SBATCH --output=job_str.out #SBATCH --error=job_str.err #SBATCH --exclusive #SBATCH --mail-type=end module load GCC/ OpenMPI/1.10.3

45 Setting up the system, minimization, solvation, equilibration, produ CHARMM Setting up the system minimization solvation neutralization equilibration production analysis

46 Setting up the system, minimization, solvation, equilibration, produ CHARMM files *.pdb (coordinates) CHARMM parameter files *.inp (input file for simulation)

47 Setting up the system, minimization, solvation, equilibration, produ Performance of CHARMM Figure : Old CHARMM version. Figure : Comparison of CHARMM with other novel software. System of 19,609 atoms. JCC, 35, (2014)

48 Setting up the system, minimization, solvation, equilibration, produ CHARMM support contact HPC2N support

What is Classical Molecular Dynamics?

What is Classical Molecular Dynamics? What is Classical Molecular Dynamics? Simulation of explicit particles (atoms, ions,... ) Particles interact via relatively simple analytical potential functions Newton s equations of motion are integrated

More information

Ab initio molecular dynamics. Simone Piccinin CNR-IOM DEMOCRITOS Trieste, Italy. Bangalore, 04 September 2014

Ab initio molecular dynamics. Simone Piccinin CNR-IOM DEMOCRITOS Trieste, Italy. Bangalore, 04 September 2014 Ab initio molecular dynamics Simone Piccinin CNR-IOM DEMOCRITOS Trieste, Italy Bangalore, 04 September 2014 What is MD? 1) Liquid 4) Dye/TiO2/electrolyte 2) Liquids 3) Solvated protein 5) Solid to liquid

More information

Free energy calculations and the potential of mean force

Free energy calculations and the potential of mean force Free energy calculations and the potential of mean force IMA Workshop on Classical and Quantum Approaches in Molecular Modeling Mark Tuckerman Dept. of Chemistry and Courant Institute of Mathematical Science

More information

A Nobel Prize for Molecular Dynamics and QM/MM What is Classical Molecular Dynamics? Simulation of explicit particles (atoms, ions,... ) Particles interact via relatively simple analytical potential

More information

Molecular Dynamics Simulations. Dr. Noelia Faginas Lago Dipartimento di Chimica,Biologia e Biotecnologie Università di Perugia

Molecular Dynamics Simulations. Dr. Noelia Faginas Lago Dipartimento di Chimica,Biologia e Biotecnologie Università di Perugia Molecular Dynamics Simulations Dr. Noelia Faginas Lago Dipartimento di Chimica,Biologia e Biotecnologie Università di Perugia 1 An Introduction to Molecular Dynamics Simulations Macroscopic properties

More information

Gear methods I + 1/18

Gear methods I + 1/18 Gear methods I + 1/18 Predictor-corrector type: knowledge of history is used to predict an approximate solution, which is made more accurate in the following step we do not want (otherwise good) methods

More information

Molecular dynamics simulation of Aquaporin-1. 4 nm

Molecular dynamics simulation of Aquaporin-1. 4 nm Molecular dynamics simulation of Aquaporin-1 4 nm Molecular Dynamics Simulations Schrödinger equation i~@ t (r, R) =H (r, R) Born-Oppenheimer approximation H e e(r; R) =E e (R) e(r; R) Nucleic motion described

More information

Simulation of molecular systems by molecular dynamics

Simulation of molecular systems by molecular dynamics Simulation of molecular systems by molecular dynamics Yohann Moreau yohann.moreau@ujf-grenoble.fr November 26, 2015 Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, 2015 1 / 35 Introduction

More information

Molecular Dynamics. A very brief introduction

Molecular Dynamics. A very brief introduction Molecular Dynamics A very brief introduction Sander Pronk Dept. of Theoretical Physics KTH Royal Institute of Technology & Science For Life Laboratory Stockholm, Sweden Why computer simulations? Two primary

More information

Introduction to molecular dynamics

Introduction to molecular dynamics 1 Introduction to molecular dynamics Yves Lansac Université François Rabelais, Tours, France Visiting MSE, GIST for the summer Molecular Simulation 2 Molecular simulation is a computational experiment.

More information

LAMMPS Performance Benchmark on VSC-1 and VSC-2

LAMMPS Performance Benchmark on VSC-1 and VSC-2 LAMMPS Performance Benchmark on VSC-1 and VSC-2 Daniel Tunega and Roland Šolc Institute of Soil Research, University of Natural Resources and Life Sciences VSC meeting, Neusiedl am See, February 27-28,

More information

Introduction to Classical Molecular Dynamics. Giovanni Chillemi HPC department, CINECA

Introduction to Classical Molecular Dynamics. Giovanni Chillemi HPC department, CINECA Introduction to Classical Molecular Dynamics Giovanni Chillemi g.chillemi@cineca.it HPC department, CINECA MD ingredients Coordinates Velocities Force field Topology MD Trajectories Input parameters Analysis

More information

Understanding Molecular Simulation 2009 Monte Carlo and Molecular Dynamics in different ensembles. Srikanth Sastry

Understanding Molecular Simulation 2009 Monte Carlo and Molecular Dynamics in different ensembles. Srikanth Sastry JNCASR August 20, 21 2009 Understanding Molecular Simulation 2009 Monte Carlo and Molecular Dynamics in different ensembles Srikanth Sastry Jawaharlal Nehru Centre for Advanced Scientific Research, Bangalore

More information

Set the initial conditions r i. Update neighborlist. r i. Get new forces F i

Set the initial conditions r i. Update neighborlist. r i. Get new forces F i Set the initial conditions r i t 0, v i t 0 Update neighborlist Get new forces F i r i Solve the equations of motion numerically over time step t : r i t n r i t n + v i t n v i t n + Perform T, P scaling

More information

Temperature and Pressure Controls

Temperature and Pressure Controls Ensembles Temperature and Pressure Controls 1. (E, V, N) microcanonical (constant energy) 2. (T, V, N) canonical, constant volume 3. (T, P N) constant pressure 4. (T, V, µ) grand canonical #2, 3 or 4 are

More information

Force fields, thermo- and barostats. Berk Hess

Force fields, thermo- and barostats. Berk Hess Force fields, thermo- and barostats Berk Hess What is a force field? A force field usually consists of three parts: a set of functional forms parameters for the functional forms that, usually, depend on

More information

Free energy simulations

Free energy simulations Free energy simulations Marcus Elstner and Tomáš Kubař January 14, 2013 Motivation a physical quantity that is of most interest in chemistry? free energies Helmholtz F or Gibbs G holy grail of computational

More information

Biomolecular modeling I

Biomolecular modeling I 2015, December 15 Biomolecular simulation Elementary body atom Each atom x, y, z coordinates A protein is a set of coordinates. (Gromacs, A. P. Heiner) Usually one molecule/complex of interest (e.g. protein,

More information

Introduction Statistical Thermodynamics. Monday, January 6, 14

Introduction Statistical Thermodynamics. Monday, January 6, 14 Introduction Statistical Thermodynamics 1 Molecular Simulations Molecular dynamics: solve equations of motion Monte Carlo: importance sampling r 1 r 2 r n MD MC r 1 r 2 2 r n 2 3 3 4 4 Questions How can

More information

MD Thermodynamics. Lecture 12 3/26/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky

MD Thermodynamics. Lecture 12 3/26/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky MD Thermodynamics Lecture 1 3/6/18 1 Molecular dynamics The force depends on positions only (not velocities) Total energy is conserved (micro canonical evolution) Newton s equations of motion (second order

More information

Why Proteins Fold? (Parts of this presentation are based on work of Ashok Kolaskar) CS490B: Introduction to Bioinformatics Mar.

Why Proteins Fold? (Parts of this presentation are based on work of Ashok Kolaskar) CS490B: Introduction to Bioinformatics Mar. Why Proteins Fold? (Parts of this presentation are based on work of Ashok Kolaskar) CS490B: Introduction to Bioinformatics Mar. 25, 2002 Molecular Dynamics: Introduction At physiological conditions, the

More information

Methods of Computer Simulation. Molecular Dynamics and Monte Carlo

Methods of Computer Simulation. Molecular Dynamics and Monte Carlo Molecular Dynamics Time is of the essence in biological processes therefore how do we understand time-dependent processes at the molecular level? How do we do this experimentally? How do we do this computationally?

More information

Nanoscale simulation lectures Statistical Mechanics

Nanoscale simulation lectures Statistical Mechanics Nanoscale simulation lectures 2008 Lectures: Thursdays 4 to 6 PM Course contents: - Thermodynamics and statistical mechanics - Structure and scattering - Mean-field approaches - Inhomogeneous systems -

More information

Molecular Interactions F14NMI. Lecture 4: worked answers to practice questions

Molecular Interactions F14NMI. Lecture 4: worked answers to practice questions Molecular Interactions F14NMI Lecture 4: worked answers to practice questions http://comp.chem.nottingham.ac.uk/teaching/f14nmi jonathan.hirst@nottingham.ac.uk (1) (a) Describe the Monte Carlo algorithm

More information

Introduction to Computer Simulations of Soft Matter Methodologies and Applications Boulder July, 19-20, 2012

Introduction to Computer Simulations of Soft Matter Methodologies and Applications Boulder July, 19-20, 2012 Introduction to Computer Simulations of Soft Matter Methodologies and Applications Boulder July, 19-20, 2012 K. Kremer Max Planck Institute for Polymer Research, Mainz Overview Simulations, general considerations

More information

7 To solve numerically the equation of motion, we use the velocity Verlet or leap frog algorithm. _ V i n = F i n m i (F.5) For time step, we approxim

7 To solve numerically the equation of motion, we use the velocity Verlet or leap frog algorithm. _ V i n = F i n m i (F.5) For time step, we approxim 69 Appendix F Molecular Dynamics F. Introduction In this chapter, we deal with the theories and techniques used in molecular dynamics simulation. The fundamental dynamics equations of any system is the

More information

Molecular Dynamics Simulations

Molecular Dynamics Simulations Molecular Dynamics Simulations Dr. Kasra Momeni www.knanosys.com Outline Long-range Interactions Ewald Sum Fast Multipole Method Spherically Truncated Coulombic Potential Speeding up Calculations SPaSM

More information

Gromacs Workshop Spring CSC

Gromacs Workshop Spring CSC Gromacs Workshop Spring 2007 @ CSC Erik Lindahl Center for Biomembrane Research Stockholm University, Sweden David van der Spoel Dept. Cell & Molecular Biology Uppsala University, Sweden Berk Hess Max-Planck-Institut

More information

Biomolecules are dynamic no single structure is a perfect model

Biomolecules are dynamic no single structure is a perfect model Molecular Dynamics Simulations of Biomolecules References: A. R. Leach Molecular Modeling Principles and Applications Prentice Hall, 2001. M. P. Allen and D. J. Tildesley "Computer Simulation of Liquids",

More information

Advanced Molecular Dynamics

Advanced Molecular Dynamics Advanced Molecular Dynamics Introduction May 2, 2017 Who am I? I am an associate professor at Theoretical Physics Topics I work on: Algorithms for (parallel) molecular simulations including GPU acceleration

More information

The Molecular Dynamics Method

The Molecular Dynamics Method The Molecular Dynamics Method Thermal motion of a lipid bilayer Water permeation through channels Selective sugar transport Potential Energy (hyper)surface What is Force? Energy U(x) F = d dx U(x) Conformation

More information

Aspects of nonautonomous molecular dynamics

Aspects of nonautonomous molecular dynamics Aspects of nonautonomous molecular dynamics IMA, University of Minnesota, Minneapolis January 28, 2007 Michel Cuendet Swiss Institute of Bioinformatics, Lausanne, Switzerland Introduction to the Jarzynski

More information

Analysis of MD Results Using Statistical Mechanics Methods. Molecular Modeling

Analysis of MD Results Using Statistical Mechanics Methods. Molecular Modeling Analysis of MD Results Using Statistical Mechanics Methods Ioan Kosztin eckman Institute University of Illinois at Urbana-Champaign Molecular Modeling. Model building. Molecular Dynamics Simulation 3.

More information

The micro-properties of [hmpy+] [Tf 2 N-] Ionic liquid: a simulation. study. 1. Introduction

The micro-properties of [hmpy+] [Tf 2 N-] Ionic liquid: a simulation. study. 1. Introduction ISBN 978-1-84626-081-0 Proceedings of the 2010 International Conference on Application of Mathematics and Physics Volume 1: Advances on Space Weather, Meteorology and Applied Physics Nanjing, P. R. China,

More information

Generation of topology files of a protein chain and simulations of a dipeptide

Generation of topology files of a protein chain and simulations of a dipeptide Chapter-36 Generation of topology files of a protein chain and simulations of a dipeptide After studying this chapter, you will be able to 1) Generate a topology file of a dipeptide molecule. 2) Generate

More information

Introduction to Simulation - Lectures 17, 18. Molecular Dynamics. Nicolas Hadjiconstantinou

Introduction to Simulation - Lectures 17, 18. Molecular Dynamics. Nicolas Hadjiconstantinou Introduction to Simulation - Lectures 17, 18 Molecular Dynamics Nicolas Hadjiconstantinou Molecular Dynamics Molecular dynamics is a technique for computing the equilibrium and non-equilibrium properties

More information

ChE 210B: Advanced Topics in Equilibrium Statistical Mechanics

ChE 210B: Advanced Topics in Equilibrium Statistical Mechanics ChE 210B: Advanced Topics in Equilibrium Statistical Mechanics Glenn Fredrickson Lecture 1 Reading: 3.1-3.5 Chandler, Chapters 1 and 2 McQuarrie This course builds on the elementary concepts of statistical

More information

NWChem: Molecular Dynamics and QM/MM

NWChem: Molecular Dynamics and QM/MM NWChem: Molecular Dynamics and QM/MM Molecular Dynamics Functionality Target systems: General features: biomolecules (proteins, DNA/RNA, biomembranes) energy evaluation (SP) energy minimization (EM) molecular

More information

Van Gunsteren et al. Angew. Chem. Int. Ed. 45, 4064 (2006)

Van Gunsteren et al. Angew. Chem. Int. Ed. 45, 4064 (2006) Van Gunsteren et al. Angew. Chem. Int. Ed. 45, 4064 (2006) Martini Workshop 2015 Coarse Graining Basics Alex de Vries Every word or concept, clear as it may seem to be, has only a limited range of applicability

More information

Energy and Forces in DFT

Energy and Forces in DFT Energy and Forces in DFT Total Energy as a function of nuclear positions {R} E tot ({R}) = E DF T ({R}) + E II ({R}) (1) where E DF T ({R}) = DFT energy calculated for the ground-state density charge-density

More information

Why study protein dynamics?

Why study protein dynamics? Why study protein dynamics? Protein flexibility is crucial for function. One average structure is not enough. Proteins constantly sample configurational space. Transport - binding and moving molecules

More information

Principles and Applications of Molecular Dynamics Simulations with NAMD

Principles and Applications of Molecular Dynamics Simulations with NAMD Principles and Applications of Molecular Dynamics Simulations with NAMD Nov. 14, 2016 Computational Microscope NCSA supercomputer JC Gumbart Assistant Professor of Physics Georgia Institute of Technology

More information

A Brief Introduction to Statistical Mechanics

A Brief Introduction to Statistical Mechanics A Brief Introduction to Statistical Mechanics E. J. Maginn, J. K. Shah Department of Chemical and Biomolecular Engineering University of Notre Dame Notre Dame, IN 46556 USA Monte Carlo Workshop Universidade

More information

Multiscale Materials Modeling

Multiscale Materials Modeling Multiscale Materials Modeling Lecture 02 Capabilities of Classical Molecular Simulation These notes created by David Keffer, University of Tennessee, Knoxville, 2009. Outline Capabilities of Classical

More information

Constant Pressure Langevin Dynamics: Theory and Application to the Study of Phase Behaviour in Core-Softened Systems.

Constant Pressure Langevin Dynamics: Theory and Application to the Study of Phase Behaviour in Core-Softened Systems. Constant Pressure Langevin Dynamics: Theory and Application to the Study of Phase Behaviour in Core-Softened Systems. David Quigley A thesis submitted for the degree of Doctor of Philosophy University

More information

Ab initio molecular dynamics and nuclear quantum effects

Ab initio molecular dynamics and nuclear quantum effects Ab initio molecular dynamics and nuclear quantum effects Luca M. Ghiringhelli Fritz Haber Institute Hands on workshop density functional theory and beyond: First principles simulations of molecules and

More information

Monte Carlo Methods in Statistical Mechanics

Monte Carlo Methods in Statistical Mechanics Monte Carlo Methods in Statistical Mechanics Mario G. Del Pópolo Atomistic Simulation Centre School of Mathematics and Physics Queen s University Belfast Belfast Mario G. Del Pópolo Statistical Mechanics

More information

Supporting Information

Supporting Information Supporting Information Structure and Dynamics of Uranyl(VI) and Plutonyl(VI) Cations in Ionic Liquid/Water Mixtures via Molecular Dynamics Simulations Katie A. Maerzke, George S. Goff, Wolfgang H. Runde,

More information

Protein Structure Analysis

Protein Structure Analysis BINF 731 Protein Modeling Methods Protein Structure Analysis Iosif Vaisman Ab initio methods: solution of a protein folding problem search in conformational space Energy-based methods: energy minimization

More information

4 th Advanced in silico Drug Design KFC/ADD Molecular Modelling Intro. Karel Berka, Ph.D.

4 th Advanced in silico Drug Design KFC/ADD Molecular Modelling Intro. Karel Berka, Ph.D. 4 th Advanced in silico Drug Design KFC/ADD Molecular Modelling Intro Karel Berka, Ph.D. UP Olomouc, 21.1.-25.1. 2019 Motto A theory is something nobody believes, except the person who made it An experiment

More information

LECTURE 6 : BASICS FOR MOLECULAR SIMULATIONS - Historical perspective - Skimming over Statistical Mechanics - General idea of Molecular Dynamics -

LECTURE 6 : BASICS FOR MOLECULAR SIMULATIONS - Historical perspective - Skimming over Statistical Mechanics - General idea of Molecular Dynamics - LECTURE 6 : BASICS FOR MOLECULAR SIMULATIONS - Historical perspective - Skimming over Statistical Mechanics - General idea of Molecular Dynamics - Force calculations, structure of MD, equations of motion

More information

Protein Structure Analysis

Protein Structure Analysis BINF 731 Protein Modeling Methods Protein Structure Analysis Iosif Vaisman Ab initio methods: solution of a protein folding problem search in conformational space Energy-based methods: energy minimization

More information

Phase Equilibria and Molecular Solutions Jan G. Korvink and Evgenii Rudnyi IMTEK Albert Ludwig University Freiburg, Germany

Phase Equilibria and Molecular Solutions Jan G. Korvink and Evgenii Rudnyi IMTEK Albert Ludwig University Freiburg, Germany Phase Equilibria and Molecular Solutions Jan G. Korvink and Evgenii Rudnyi IMTEK Albert Ludwig University Freiburg, Germany Preliminaries Learning Goals Phase Equilibria Phase diagrams and classical thermodynamics

More information

Ab Initio Molecular Dynamic

Ab Initio Molecular Dynamic Ab Initio Molecular Dynamic Paul Fleurat-Lessard AtoSim Master / RFCT Ab Initio Molecular Dynamic p.1/67 Summary I. Introduction II. Classical Molecular Dynamic III. Ab Initio Molecular Dynamic (AIMD)

More information

Molecular Dynamics Simulation of Methanol-Water Mixture

Molecular Dynamics Simulation of Methanol-Water Mixture Molecular Dynamics Simulation of Methanol-Water Mixture Palazzo Mancini, Mara Cantoni University of Urbino Carlo Bo Abstract In this study some properties of the methanol-water mixture such as diffusivity,

More information

JASS Modeling and visualization of molecular dynamic processes

JASS Modeling and visualization of molecular dynamic processes JASS 2009 Konstantin Shefov Modeling and visualization of molecular dynamic processes St Petersburg State University, Physics faculty, Department of Computational Physics Supervisor PhD Stepanova Margarita

More information

Javier Junquera. Statistical mechanics

Javier Junquera. Statistical mechanics Javier Junquera Statistical mechanics From the microscopic to the macroscopic level: the realm of statistical mechanics Computer simulations Thermodynamic state Generates information at the microscopic

More information

Ab Initio Molecular Dynamic

Ab Initio Molecular Dynamic Ab Initio Molecular Dynamic Paul Fleurat-Lessard AtoSim Master Ab Initio Molecular Dynamic p.1/67 Summary I. Introduction II. Classical Molecular Dynamic III. Ab Initio Molecular Dynamic (AIMD) 1 - Which

More information

Molecular Dynamics at Constant Pressure: Allowing the System to Control Volume Fluctuations via a Shell Particle

Molecular Dynamics at Constant Pressure: Allowing the System to Control Volume Fluctuations via a Shell Particle Entropy 2013, 15, 3941-3969; doi:10.3390/e15093941 Review OPEN ACCESS entropy ISSN 1099-4300 www.mdpi.com/journal/entropy Molecular Dynamics at Constant Pressure: Allowing the System to Control Volume

More information

Ab Ini'o Molecular Dynamics (MD) Simula?ons

Ab Ini'o Molecular Dynamics (MD) Simula?ons Ab Ini'o Molecular Dynamics (MD) Simula?ons Rick Remsing ICMS, CCDM, Temple University, Philadelphia, PA What are Molecular Dynamics (MD) Simulations? Technique to compute statistical and transport properties

More information

Molecular simulation and structure prediction using CHARMM and the MMTSB Tool Set Free Energy Methods

Molecular simulation and structure prediction using CHARMM and the MMTSB Tool Set Free Energy Methods Molecular simulation and structure prediction using CHARMM and the MMTSB Tool Set Free Energy Methods Charles L. Brooks III MMTSB/CTBP 2006 Summer Workshop CHARMM Simulations The flow of data and information

More information

Free energy calculations using molecular dynamics simulations. Anna Johansson

Free energy calculations using molecular dynamics simulations. Anna Johansson Free energy calculations using molecular dynamics simulations Anna Johansson 2007-03-13 Outline Introduction to concepts Why is free energy important? Calculating free energy using MD Thermodynamical Integration

More information

Bioengineering 215. An Introduction to Molecular Dynamics for Biomolecules

Bioengineering 215. An Introduction to Molecular Dynamics for Biomolecules Bioengineering 215 An Introduction to Molecular Dynamics for Biomolecules David Parker May 18, 2007 ntroduction A principal tool to study biological molecules is molecular dynamics simulations (MD). MD

More information

Supporting Information

Supporting Information Projection of atomistic simulation data for the dynamics of entangled polymers onto the tube theory: Calculation of the segment survival probability function and comparison with modern tube models Pavlos

More information

Basic Ingredients of Free Energy Calculations: A Review

Basic Ingredients of Free Energy Calculations: A Review Feature Article Basic Ingredients of Free Energy Calculations: A Review CLARA D. CHRIST, 1 ALAN E. MARK, 2 WILFRED F. van GUNSTEREN 1 1 Laboratory of Physical Chemistry, Swiss Federal Institute of Technology,

More information

2008 Biowerkzeug Ltd.

2008 Biowerkzeug Ltd. 2008 Biowerkzeug Ltd. 1 Contents Summary...3 1 Simulation...4 1.1 Setup...4 1.2 Output...4 2 Settings...5 3 Analysis...9 3.1 Setup...9 3.2 Input options...9 3.3 Descriptions...10 Please note that we cannot

More information

Molecular modeling for functional materials design in chemical engineering and more

Molecular modeling for functional materials design in chemical engineering and more Molecular modeling for functional materials design in chemical engineering and more Dr inż. Łukasz Radosiński Group of Bioprocess and Biomedical Engineering Wroclaw University of Science and Technology

More information

2. Thermodynamics. Introduction. Understanding Molecular Simulation

2. Thermodynamics. Introduction. Understanding Molecular Simulation 2. Thermodynamics Introduction Molecular Simulations Molecular dynamics: solve equations of motion r 1 r 2 r n Monte Carlo: importance sampling r 1 r 2 r n How do we know our simulation is correct? Molecular

More information

Advanced in silico drug design

Advanced in silico drug design Advanced in silico drug design RNDr. Martin Lepšík, Ph.D. Lecture: Advanced scoring Palacky University, Olomouc 2016 1 Outline 1. Scoring Definition, Types 2. Physics-based Scoring: Master Equation Terms

More information

(# = %(& )(* +,(- Closed system, well-defined energy (or e.g. E± E/2): Microcanonical ensemble

(# = %(& )(* +,(- Closed system, well-defined energy (or e.g. E± E/2): Microcanonical ensemble Recall from before: Internal energy (or Entropy): &, *, - (# = %(& )(* +,(- Closed system, well-defined energy (or e.g. E± E/2): Microcanonical ensemble & = /01Ω maximized Ω: fundamental statistical quantity

More information

Biomolecular modeling III

Biomolecular modeling III 2016, January 5 Déjà vu Enhanced sampling Biomolecular simulation Each atom x, y, z coordinates Déjà vu Enhanced sampling Expression for energy the force field = 1 2 + N i i k i (r i r 0 i ) 2 + 1 2 N

More information

An introduction to Molecular Dynamics. EMBO, June 2016

An introduction to Molecular Dynamics. EMBO, June 2016 An introduction to Molecular Dynamics EMBO, June 2016 What is MD? everything that living things do can be understood in terms of the jiggling and wiggling of atoms. The Feynman Lectures in Physics vol.

More information

Brief Review of Statistical Mechanics

Brief Review of Statistical Mechanics Brief Review of Statistical Mechanics Introduction Statistical mechanics: a branch of physics which studies macroscopic systems from a microscopic or molecular point of view (McQuarrie,1976) Also see (Hill,1986;

More information

Biomolecular modeling. Theoretical Chemistry, TU Braunschweig (Dated: December 10, 2010)

Biomolecular modeling. Theoretical Chemistry, TU Braunschweig (Dated: December 10, 2010) Biomolecular modeling Marcus Elstner and Tomáš Kubař Theoretical Chemistry, TU Braunschweig (Dated: December 10, 2010) IX. FREE ENERGY SIMULATIONS When searching for a physical quantity that is of most

More information

Organization of NAMD Tutorial Files

Organization of NAMD Tutorial Files Organization of NAMD Tutorial Files .1.1. RMSD for individual residues Objective: Find the average RMSD over time of each residue in the protein using VMD. Display the protein with the residues colored

More information

Applications of Molecular Dynamics

Applications of Molecular Dynamics June 4, 0 Molecular Modeling and Simulation Applications of Molecular Dynamics Agricultural Bioinformatics Research Unit, Graduate School of Agricultural and Life Sciences, The University of Tokyo Tohru

More information

CHE3935. Lecture 4 Quantum Mechanical Simulation Methods Continued

CHE3935. Lecture 4 Quantum Mechanical Simulation Methods Continued CHE3935 Lecture 4 Quantum Mechanical Simulation Methods Continued 1 OUTLINE Review Introduction to CPMD MD and ensembles The functionals of density functional theory Return to ab initio methods Binding

More information

TSTC Lectures: Theoretical & Computational Chemistry

TSTC Lectures: Theoretical & Computational Chemistry TSTC Lectures: Theoretical & Computational Chemistry Rigoberto Hernandez May 2009, Lecture #2 Statistical Mechanics: Structure S = k B log W! Boltzmann's headstone at the Vienna Zentralfriedhof.!! Photo

More information

Supporting Information

Supporting Information Supporting Information ph-responsive self-assembly of polysaccharide through a rugged energy landscape Brian H. Morrow, Gregory F. Payne, and Jana Shen Department of Pharmaceutical Sciences, School of

More information

Citation for published version (APA): Hess, B. (2002). Stochastic concepts in molecular simulation Groningen: s.n.

Citation for published version (APA): Hess, B. (2002). Stochastic concepts in molecular simulation Groningen: s.n. University of Groningen Stochastic concepts in molecular simulation Hess, Berk IMPORTANT NOTE: You are advised to consult the publisher's version (publisher's PDF) if you wish to cite from it. Please check

More information

Optimizing GROMACS for parallel performance

Optimizing GROMACS for parallel performance Optimizing GROMACS for parallel performance Outline 1. Why optimize? Performance status quo 2. GROMACS as a black box. (PME) 3. How does GROMACS spend its time? (MPE) 4. What you can do What I want to

More information

Many-Body Coarse-Grained Interactions using Gaussian Approximation Potentials

Many-Body Coarse-Grained Interactions using Gaussian Approximation Potentials Many-Body Coarse-Grained Interactions using Gaussian Approximation Potentials arxiv:1611.09123v2 [cond-mat.soft] 28 Sep 2017 S.T. John Peterhouse September 2016 This dissertation is submitted for the degree

More information

Controlling fluctuations

Controlling fluctuations Controlling fluctuations Michele Parrinello Department of Chemistry and Applied Biosciences ETH Zurich and ICS, Università della Svizzera Italiana, Lugano, Switzerland Today s menu Introduction Fluctuations

More information

Classical Molecular Dynamics

Classical Molecular Dynamics Classical Molecular Dynamics Matt Probert Condensed Matter Dynamics Group Department of Physics, University of York, U.K. http://www-users.york.ac.uk/~mijp1 Overview of lecture n Motivation n Types of

More information

Molecular Dynamics Simulation of a Nanoconfined Water Film

Molecular Dynamics Simulation of a Nanoconfined Water Film Molecular Dynamics Simulation of a Nanoconfined Water Film Kyle Lindquist, Shu-Han Chao May 7, 2013 1 Introduction The behavior of water confined in nano-scale environment is of interest in many applications.

More information

Monte Carlo Methods. Ensembles (Chapter 5) Biased Sampling (Chapter 14) Practical Aspects

Monte Carlo Methods. Ensembles (Chapter 5) Biased Sampling (Chapter 14) Practical Aspects Monte Carlo Methods Ensembles (Chapter 5) Biased Sampling (Chapter 14) Practical Aspects Lecture 1 2 Lecture 1&2 3 Lecture 1&3 4 Different Ensembles Ensemble ame Constant (Imposed) VT Canonical,V,T P PT

More information

Supporting Information. for. Influence of Cononsolvency on the. Aggregation of Tertiary Butyl Alcohol in. Methanol-Water Mixtures

Supporting Information. for. Influence of Cononsolvency on the. Aggregation of Tertiary Butyl Alcohol in. Methanol-Water Mixtures Supporting Information for Influence of Cononsolvency on the Aggregation of Tertiary Butyl Alcohol in Methanol-Water Mixtures Kenji Mochizuki,, Shannon R. Pattenaude, and Dor Ben-Amotz Research Institute

More information

Ab initio molecular dynamics

Ab initio molecular dynamics Ab initio molecular dynamics Molecular dynamics Why? allows realistic simulation of equilibrium and transport properties in Nature ensemble averages can be used for statistical mechanics time evolution

More information

Efficient Parallelization of Molecular Dynamics Simulations on Hybrid CPU/GPU Supercoputers

Efficient Parallelization of Molecular Dynamics Simulations on Hybrid CPU/GPU Supercoputers Efficient Parallelization of Molecular Dynamics Simulations on Hybrid CPU/GPU Supercoputers Jaewoon Jung (RIKEN, RIKEN AICS) Yuji Sugita (RIKEN, RIKEN AICS, RIKEN QBiC, RIKEN ithes) Molecular Dynamics

More information

2D Clausius Clapeyron equation

2D Clausius Clapeyron equation 2D Clausius Clapeyron equation 1/14 Aim: Verify the Clausius Clapeyron equation by simulations of a 2D model of matter Model: 8-4 type potential ( Lennard-Jones in 2D) u(r) = 1 r 8 1 r 4 Hard attractive

More information

Free Energy Simulation Methods

Free Energy Simulation Methods Free Energy Simulation Methods Free energy simulation methods Many methods have been developed to compute (relative) free energies on the basis of statistical mechanics Free energy perturbation Thermodynamic

More information

The Molecular Dynamics Simulation Process

The Molecular Dynamics Simulation Process The Molecular Dynamics Simulation Process For textbooks see: M.P. Allen and D.J. Tildesley. Computer Simulation of Liquids.Oxford University Press, New York, 1987. D. Frenkel and B. Smit. Understanding

More information

Universal Repulsive Contribution to the. Solvent-Induced Interaction Between Sizable, Curved Hydrophobes: Supporting Information

Universal Repulsive Contribution to the. Solvent-Induced Interaction Between Sizable, Curved Hydrophobes: Supporting Information Universal Repulsive Contribution to the Solvent-Induced Interaction Between Sizable, Curved Hydrophobes: Supporting Information B. Shadrack Jabes, Dusan Bratko, and Alenka Luzar Department of Chemistry,

More information

Molecular Dynamics in practice with GROMACS

Molecular Dynamics in practice with GROMACS Molecular Dynamics in practice with GROMACS GROMACS is one of the wold s fastest software package for molecular dynamics simulations. One can find many helpful materials, manual as well as to download

More information

MARTINI simulation details

MARTINI simulation details S1 Appendix MARTINI simulation details MARTINI simulation initialization and equilibration In this section, we describe the initialization of simulations from Main Text section Residue-based coarsegrained

More information

Supporting Information

Supporting Information Supporting Information Sánchez et al. 10.1073/pnas.1612893114 SI Materials and Methods Growth of Single Crystalline Ice. The single crystal ice boule growth method is based on withdrawing a single crystalline

More information

Molecular Modeling of Matter

Molecular Modeling of Matter Molecular Modeling of Matter Keith E. Gubbins Lecture 2 Atomistic Simulation. General Features. Molecular Dynamics Outline General features of atomistic simulation Brief description of MC and MD Features

More information

Ionic Liquids simulations : obtention of structural and transport properties from molecular dynamics. C. J. F. Solano, D. Beljonne, R.

Ionic Liquids simulations : obtention of structural and transport properties from molecular dynamics. C. J. F. Solano, D. Beljonne, R. Ionic Liquids simulations : obtention of structural and transport properties from molecular dynamics C. J. F. Solano, D. Beljonne, R. Lazzaroni Ionic Liquids simulations : obtention of structural and transport

More information

CASSANDRA. Computational Atomistic Simulation Software At Notre Dame for Research Advances

CASSANDRA. Computational Atomistic Simulation Software At Notre Dame for Research Advances 1 CASSANDRA Computational Atomistic Simulation Software At Notre Dame for Research Advances User Manual 1.1 Written by: Edward J. Maginn, Jindal K. Shah, Eliseo Marin-Rimoldi, Brian P. Keene, Sandip Khan,

More information

Diffusion of Water and Diatomic Oxygen in Poly(3-hexylthiophene) Melt: A Molecular Dynamics Simulation Study

Diffusion of Water and Diatomic Oxygen in Poly(3-hexylthiophene) Melt: A Molecular Dynamics Simulation Study Diffusion of Water and Diatomic Oxygen in Poly(3-hexylthiophene) Melt: A Molecular Dynamics Simulation Study Julia Deitz, Yeneneh Yimer, and Mesfin Tsige Department of Polymer Science University of Akron

More information