Molecular dynamics: Car-Parrinello method

Size: px
Start display at page:

Download "Molecular dynamics: Car-Parrinello method"

Transcription

1 Formulations Potential energy Initialization Verlet algorithm MD: Steps MD: Thermo and barostats CP: Car-Parrinello Atomic units MD and CP textbo Molecular dynamics: Car-Parrinello method Víctor Luaña ( ) & Alberto Otero-de-la-Roza ( ) ( ) Departamento de Química Física y Analítica, Universidad de Oviedo ( ) University of California at Merced European school on Theoretical Solid State Chemistry ZCAM, Zaragoza, May 13 17, 2013 V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

2 Content 1 Statistical mechanics 2 MD: Hits 3 MD: Classical mechanics formulations 4 MD: Source of potential energy 5 MD: System and initialization 6 MD: Solving numerically the equations of motion: Verlet (1967) 7 MD: Steps in a MD simulation 8 Ensemble constraints in MD: Thermostats and barostats 9 The Car-Parrinello formulation V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

3 Statistical mechanics Gibbs ensembles method: microcanonical: Ω(N, V, E) S = k ln Ω canonical: Q(N, V, T) = Ω(N, V, E)e E i /kt i A = kt ln Q grand canonical: Ξ(µ, V, T) = N Q(N, V, E)e Nµ/kT pv = kt ln Ξ iso-pt: (N, p, T) = V Q(N, V, E)e pv/kt G = kt ln Independent particles: Boltzmann (classical), Maxwell-Boltzmann (velocities), Fermi-Dirac, Bose-Einstein,... Molecular dynamics: Integrate the equations of motion for all the particles in the system. Check the ergodicity of the statistical sampling: A = 1 τ lim A(τ)dτ τ τ 0 Formally equivalent to a microcanonical ensemble, use constraints (thermostats, barostats,...) for other ensembles. Monte-Carlo methods: Choose randomly a Markov chain of states (the new state depends only on the current one, the process is memoryless) Accepting a new state depends on the Metropolis rule: accept always if the energy diminishes ( E = E i E i 1 < 0) and accept movements such that E > 0 with a probability P( E) e E/kT. Check the ergodicity of the statis- 1 tical sampling: A = lim N N N A i. i=1 V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

4 MD: History Boltzmann equation (S = k ln Ω) 1902 Gibbs book on statistical mechanics 1952 MANIAC operational at Los Alamos 1953 [Metropolis, Rosenbluth (2), Teller (2)] Metropolis Monte Carlo method 1954 [Fermi, Pasta, Ulam] experiment on ergodicity 1956 [Livermore: Alder, Wainwright] hard spheres dynamics 1959 [Brookhaven: Vineyard] radiation damage in Cu 1964 [Argonne: Rahman] liquid Argon 1967 [Verlet] correlation functions 1970 [Livermore: Alder, Wainwright] long time tails 1977 [Ryckaert, Ciccoti and Berendsen] SHAKE: include constraints avoiding matrix inversion 1980 [Anderson, Rahman, Parrinello] constant pressure MD 1983 [Nosé, Hoover] constant temperature MD 1985 [Sissa: Car, Parrinello] CPMD 1997 [Berendsen] LINCS: non-iterative efficient way to apply bond constraints V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

5 Molecular Dynamics: classical formulations Any classical formulation can be used: Newton: U = U(R N ) F i = Ri U = M i Ri, (1) Lagrange: L = T U d L = L, (2) dt Ṙi R i Hamilton: H = p i q i L Ṙi = H = P i ; Ṗ i = H = F i. (3) P i i M i R i p i = L/ q i is a generalized momentum. The Lagrange formulation is, probably, the most common for introducing thermostats and barostats. V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

6 Isaac Newton ( ) Joseph Louis Lagrange ( ) William Rowan Hamilton ( ) V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

7 MD: Source of potential energy I Empirical force fields (MM: molecular mechanics) = bond nonbonded {}}{{}}{ U(R N ) = E bond + E angle + E dihedral + E electrostatics + E vdw (4) N E i (R i ) + 1 N E ij ( R i R j ) + 1 N E ijk (R i, R j, R k ) i i>j i>j>k }{{}}{{}}{{} 1body 2body 3body Typically developed for particular kinds of compounds: aminoacids, sugars, organometallics,... Usually developed and validated with an empirical set of data. Some popular: AMBER (Assisted Model Building and Energy Refinement, CHARMM (Chemistry at Harvard macromolecular mechamics, MM2, MM3, MM4 (Allinger s MM), GROMACS (GRÖningen MAchine for Chemical Simulations, gromacs.org/), UFF (Universal FF),... Codes: amber (ambermd.org), dl_poly ( gromacs ( lammps (lammps.sandia.gov), moldy ( moldy.html), namd ( V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

8 MD: Source of potential energy II Born-Oppenheimer dynamics (BOMD) ĤΨ(x R) = E(R)Ψ(x R) HF,... = DFT:KS SCF: ˆF i ψ i = ɛ i ψ i F I = I E(R) (5) Car-Parrinello dynamics (CPMD) L BO (Ψ, R, Ṙ) = L CP ({ψ}, { ψ}, R, Ṙ) = N i=1 1 2 M iṙi E BO (Ψ, R) (6) N 1 2 M occ IṘI + µ ψ i ψ i EBO KS ({ψ i}, R) (7) I=1 i Codes: cpmd ( cp2k ( siesta ( leem/siesta/), quantum espresso ( Rare event methods (metadynamics,...): Designed to study phenomena that would require imposibly large simulation times to occur using conventional MD techniques. Example: protein folding. Codes: plumed ( Visualization codes: jmol (jmol.org), rasmol ( vmd ( V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

9 MD: System and initialization Periodic boundary conditions: N atoms per cell. Atom properties (i [1, N]): {R, Ṙ, Ḟ,...}(i), i mod(i, N) + 1. (8) Large unit cells are used to simulate finite systems: Avoid interactions between atoms in different cells. LUC s can be used to simulate molecules, 1D chains, slabs, surfaces, impurities and defects. A crystal configuration + some randomness can be used to create the initial geometry: fcc, sc, bcc, and hcp are typical start confugurations for gases and liquids. Maxwell-Boltzmann distribution is used for the starting velocities: ( ) 3/2 ) m f (v)dv = 4π v 2 exp( mv2 (9) 2πkT 2kT Simulation can include periods of heating and or compressing: Every time the thermodynamic conditions are changed, a period of equilibration must follow, that is discarded for obtaining the average properties. V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

10 Solving numerically the equations of motion: Verlet (1967) I Taylor expansion: Verlet algorithm: [O( t 4 )] r(t ± t) = r(t) + ṙ(t) t + f(t) 2m t r 3! t 3 t3 + O( t 4 ) (10) r(t + t) = 2r(t) r(t t) + f(t) m t2, ṙ(t) = r(t + t) r(t t). (11) 2 t Verlet integrator is symplectic: satisfies time reversibility and it is robust against time step increase. Velocity Verlet algorithm: r(t + t) = r(t) + ṙ t + f(t) 2m t2, ṙ(t + t) = ṙ(t) + f(t) + f(t + t ) t. (12) 2m Position and velocity Verlet schemes are equivalent. Lyapunov instability: Trajectories through phase space can be very sensitive to the initial conditions, so trajectories that are initially very close will diverge exponentially as time goes. For a correct statistical prediction we only need we only need the trajectory to stay close to the true path long enough compared to the time for the unstability to develop. V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

11 Solving numerically the equations of motion: Verlet (1967) II The stability depends on the time step and the time of simulation. Verlet algorithm conserves energy only on the t 0 limit. V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

12 Solving numerically the equations of motion: Verlet (1967) III Checking energy conservation is a good test for t. V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

13 Solving numerically the equations of motion: Verlet (1967) IV We are interested in the stability of properties. V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

14 Steps in a MD simulation I Energy fcc Ar 32 (200 K) Equilibration Production U 220 E V K Steps Volume Discard the equlibration period when obtainig the average properties. Temperature: 3 1 N Nk T = M i Ṙ i=1 rms displacement: RMSD α(t) = 1 N α (R α(t) r α ) 2 N α α=1 Radial correlation function: g(r) = V N 2 i>j LJ fluid close to the triple point (T = 0.71, ρ = 0.844) δ(r R ij ) V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

15 Steps in a MD simulation II V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

16 Ensemble constraints in MD: Thermostats and barostats I Thermostats: Velocity rescaling: Every few steps all the velocities are scaled by a common factor (ṙ i λṙ i : T(λ) = λ 2 T(1)) so the average temperature corresponds to the target value. Easy and practical. Not a true thermostat. Possibly large fluctuations of temperature. Nosé-Hoover (1984): Introduce a heatbath as an integral part of the system, adding an artificial variable s, associated with a mass Q > 0. The s variable plays the role of a time scaling: dt sdt, with the rest of dynamic variables being transformed as R i R i, Ṙ i s 1Ṙ i, ṡ s 1 ṡ. The extended system is described by a lagrangian L = N i 1 2 m is 2 Ṙ 2 i + U(R) Qṡ2 gkt ln s (15) which includes a kinetic and potential energy associated to s. The time-evolution of s is described by a second-order equation. Heat may flow in and out of the system in an oscillatory fashion, leading to nearly periodic temperature fluctuations. Not (always) ergodic. Choose carefully the Q mass, or use a chain of NH thermostats. V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

17 Ensemble constraints in MD: Thermostats and barostats II An ergodic simulation must visit efficiently and randomly the phase space: Barostats: V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

18 Ensemble constraints in MD: Thermostats and barostats III Andersen (1980): Define scaled coordinates ρ i = R i /V 1/3, declare a enlarged hamiltonian: L = 1 2 Ω2/3 N m i ρ 2 i + U(Ω 1/3 ρ) M Ω 2 p 0 Ω (16) i=1 where Q represents the cell volume, p 0 is the target pressure, and Ω is the actual cell volume. Designed for an isotropic deformation of the cell. Parrinello-Rahman (1981): Generalization to allow anisotropic deformations. Let h = (a, b, c) be the row-arranged cell vectors so G = h T h is the cell metric tensor. Atomic positons are R I = hx I, where x = (x, y, z) T is the column vector of cell coordinates, each atom in the main cell having 0 x, y, z < 1. PR barostat corresponds to the Lagrangian L = 1 2 I M i ẋ T I Gẋ I U[h, {x I }] + 1 ) WTr (ḣtḣ p 0 Ω (17) 2 formed by the kinetic and potential energy of the ions, plus the kinetic and potential associated to the deformation and the isotropic expansion of the cell. W is a fictitious mass that controls the barostat fluctuations. It can be used to study reconstructive phase transitions. Wentzcovich (1991): Similar to PR, but it uses the strain instead of h as the dynamical variable. This solves the problem of PR that the trajectory is not uniquely defined. This barostat is included in quantum espresso. V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

19 The Car-Parrinello formulation I V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

20 The Car-Parrinello formulation II "The 2009 Dirac Medal recognizes the joint contributions of Roberto Car and Michele Parrinello in developing the ab initio simulation method in which they combined, elegantly and imaginatively, the quantum mechanical density functional method for the calculation of the electronic properties of matter with molecular dynamics methods for the Newtonian simulation of atomic motions. The Car-Parrinello method has had an enormous impact, joining together the fields of simulation and of electronic structure theory, and has given rise to a variety of applications well beyond condensed matter physics." V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

21 The Car-Parrinello formulation III The idea behind Car-Parrinello dynamics is to put together the ab initio electronic structure and the molecular dynamics methods. Due to the big mass difference between electrons and ions, direct solving the dynamic equations of both kinds of particles is not possible. Rather, CP designed an extended Hamiltonian where the electronic degrees of freedom are introduced through fictitious dynamical variables. At difference with Born-Oppenheimer MD, no electronic minimization is needed at each MP step, both processes taking place simultaneously at CPMD. CPMD starts with an standard electronic minimization that brings the system to the Born-Oppenheimer ground state surface. After that, the fictitious dynamics keeps the system on the electronic ground state. Each MD step moves to a different ionic configuration, the forces being consistently accurate, even if the configuration is far away from equilibrium. The fictitious mass of the electrons must be small enough to keep the trajectory adiabatic, avoiding the transfer of energy from the ionic to the electronic degrees of freedom. This also requires as timestep smaller than the usual values in other MD methods: 1 10 fs. CPMD equations derive from a Lagrangian: L = T I + T e + U + C(ortho) +... = 1 nuc M I Ṙ 2 I + 1 orb µ ψ i ψ orb i E[{R I }, {ψ i }] + Λ ij { ψ i ψ j δ ij } + other constraints 2 2 I i i>j (18) V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

22 The Car-Parrinello formulation IV where T kinetic energy (I: ions, e: electrons); U: potential energy (HF, KS,...); C(ortho): orbital orthogonality constraint. The corresponding equations of state are: M I RI = I E[{R I }, {ψ i }], µ ψ i = E ψ i that must be solved in sequence using a variation of Verlet algorithm. Why does CPMD works? Pastore, Simargiassi and Buda [Phys. Rev. A 44 (1991) 6334] show that electrons and ions move on a differente timescale, avoiding resonance and making prohibitively slow the transfer of energy between both dynamical systems: f (ω) = dt cos(ωt) ψ i ; t ψ i ; 0 0 i In calculations for insulators and semiconductors using a basis of planewaves, the frequency for the electronic oscillations occurs in the range µωe 2 [E gap, E cut ], where E gap is the band gap and E cut the planewave cutoff. As the timestep is inversely proportional to the frequency, the relation t max µ/e cut governs the largest possible timestep. orb + Λ ij ψ j. (19) j Diamond phase (Z = 8) Si CPMD(LDA) calculation: dt = 0,3 fs, µ = 300 au, τ = 6,3 ps ( steps). Electronic (triangle) and atomic normal modes and Φ-DOS. V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

23 The Car-Parrinello formulation V Oscillations do occur: orb 1 E cons = 2 µ ψ i ψ i + i I E phys = I 1 2 M IṘ2 I + Ψ H Ψ, 1 2 MIṘ2 I + Ψ H Ψ = Econs Te, 1 2 V e = Ψ H Ψ, T e = i µ ψ i ψ i. Pastore et al. [PRA 44(1991)6334] CPMD calculation of diamond-si. E cons and E phys are motion constants, V e and T e show anticorrelated oscillations. V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

24 The Car-Parrinello formulation VI Ab initio MD techniques (BOMD or CPMD) are required whenever the electronic state is important. For instance, a chemical reaction, a phase transition where chemical bonds are created or broken, or the simulation of spectroscopic phenomena. There are severe limitations on the system size and number of steps of the simulation. V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

25 The Car-Parrinello formulation VII CPMD: Classical MD: on the fly potential, forces correct even far from equilibrium, electronic degrees of freedom, adapted to creation/breaking bonds, no need to solve HΨ = EΨ after each step, scale: 10 2 atoms, pm, ps. hardwired potential, forces best close to equilibrium, no electronic degrees of freedom, not adapted to creation/breaking bonds, scale: 10 6 atoms, nm, µs. BOMD: on the fly potential, forces correct even far from equilibrium, electronic degrees of freedom, adapted to creation/breaking bonds, solve HΨ = EΨ after each step, scale: 10 2 atoms, pm, ps. V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

26 Atomic units Length (a 0 ): 1 bohr = 0, = 5, m. Energy (E h ): 1 hartree = 27,210 7 ev = 2 625,500 kj/mol = ,63 cm 1 = 6, PHz; 1 rydberg = 0,5 hartree. Time ( /E h ): 1 aut = 0, fs. Velocity (a 0 E h / ): 1 auv = 2, m/s. Temperature (E h /k): 1 aut = 3, K. Pressure (E h /a 3 0 ): 1 aup = 29, TPa. V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

27 MD and CP textbooks Statistical thermodynamics: D. A. McQuarrie, Statistical mechanics (Harper Collins, 1976). D. Chandler, Introduction to modern statistical mechanics (Oxford UP, 1987). Molecular dynamics: M. P. Allen and D. J. Tildesley, Computer simulation of liquids (Clarendon Press, 1987). D. Frenkel and B. Smit, Understanding molecular simulation (Academic Press, 2005). Raugei Simone, Introduction to molecular dynamics simulations (people.sissa.it/~raugei/ lecture_notes/md_notes.pdf) G. Bussi, Theory and tips for molecular dynamics (sites.google.com/site/giovannibussi downloads/slides.pdf, 2008). Molecular simulations: A. R. Leach, Molecular modeling (Prentice Hall, 2001). T. Schlick, Molecular modeling and simulation (Springer, 2002). Car-Parrinello and ab initio molecular dynamics: D. Marx and J. Hutter, "Ab initio molecular dynamics: Theory and implementation", in Modern methods and algorithms on quantum chemistry, J. Grotendorst (Ed.), (John von Neumann Institute, NIC series vol. 1 & 3, 2000) Volume3/marx.pdf. Raugei Simone, Introduction to Car-Parrinello molecular dynamics simulations ( sissa.it/~raugei/lecture_notes/cp.pdf) V. Luaña & A. Otero-de-la-Roza () Molecular dynamics: Car-Parrinello method ZCAM, Zaragoza / 36

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

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

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

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 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

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

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

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

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

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

Ab initio molecular dynamics: Basic Theory and Advanced Met

Ab initio molecular dynamics: Basic Theory and Advanced Met Ab initio molecular dynamics: Basic Theory and Advanced Methods Uni Mainz October 30, 2016 Bio-inspired catalyst for hydrogen production Ab-initio MD simulations are used to learn how the active site

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

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

Density Functional Theory: from theory to Applications

Density Functional Theory: from theory to Applications Density Functional Theory: from theory to Applications Uni Mainz May 27, 2012 Large barrier-activated processes time-dependent bias potential extended Lagrangian formalism Basic idea: during the MD dynamics

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

Ab initio Molecular Dynamics Born Oppenheimer and beyond

Ab initio Molecular Dynamics Born Oppenheimer and beyond Ab initio Molecular Dynamics Born Oppenheimer and beyond Reminder, reliability of MD MD trajectories are chaotic (exponential divergence with respect to initial conditions), BUT... With a good integrator

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

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

Car-Parrinello Molecular Dynamics

Car-Parrinello Molecular Dynamics Car-Parrinello Molecular Dynamics Eric J. Bylaska HPCC Group Moral: A man dreams of a miracle and wakes up with loaves of bread Erich Maria Remarque Molecular Dynamics Loop (1) Compute Forces on atoms,

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

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

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

Density Functional Theory: from theory to Applications

Density Functional Theory: from theory to Applications Density Functional Theory: from theory to Applications Uni Mainz May 14, 2012 All electrons vs pseudopotentials Classes of Basis-set Condensed phase: Bloch s th and PBC Hamann-Schlüter-Chiang pseudopotentials

More information

Part 2: Molecular Dynamics. Literature History Practical Issues

Part 2: Molecular Dynamics. Literature History Practical Issues Part 2: Molecular Dynamics Literature History Practical Issues 1 Literature A. K. Hartmann Big Practical Guide to Computer Simulations (World Scientific, 2015) M. P. Allen and D.J. Tildesley Computer Simulations

More information

Ab initio Molecular Dynamics

Ab initio Molecular Dynamics Ab initio Molecular Dynamics Jürg Hutter Department of Chemistry, University of Zurich Overview Equations of motion and Integrators General Lagrangian for AIMD Car Parrinello MD and Born Oppenheimer MD

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

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

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

Basics of Statistical Mechanics

Basics of Statistical Mechanics Basics of Statistical Mechanics Review of ensembles Microcanonical, canonical, Maxwell-Boltzmann Constant pressure, temperature, volume, Thermodynamic limit Ergodicity (see online notes also) Reading assignment:

More information

4/18/2011. Titus Beu University Babes-Bolyai Department of Theoretical and Computational Physics Cluj-Napoca, Romania

4/18/2011. Titus Beu University Babes-Bolyai Department of Theoretical and Computational Physics Cluj-Napoca, Romania 1. Introduction Titus Beu University Babes-Bolyai Department of Theoretical and Computational Physics Cluj-Napoca, Romania Bibliography Computer experiments Ensemble averages and time averages Molecular

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

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

Introduction to model potential Molecular Dynamics A3hourcourseatICTP

Introduction to model potential Molecular Dynamics A3hourcourseatICTP Introduction to model potential Molecular Dynamics A3hourcourseatICTP Alessandro Mattoni 1 1 Istituto Officina dei Materiali CNR-IOM Unità di Cagliari SLACS ICTP School on numerical methods for energy,

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

Accelerated Quantum Molecular Dynamics

Accelerated Quantum Molecular Dynamics Accelerated Quantum Molecular Dynamics Enrique Martinez, Christian Negre, Marc J. Cawkwell, Danny Perez, Arthur F. Voter and Anders M. N. Niklasson Outline Quantum MD Current approaches Challenges Extended

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

Langevin Dynamics in Constant Pressure Extended Systems

Langevin Dynamics in Constant Pressure Extended Systems Langevin Dynamics in Constant Pressure Extended Systems D. Quigley and M.I.J. Probert CMMP 2004 1 Talk Outline Molecular dynamics and ensembles. Existing methods for sampling at NPT. Langevin dynamics

More information

3.320 Lecture 18 (4/12/05)

3.320 Lecture 18 (4/12/05) 3.320 Lecture 18 (4/12/05) Monte Carlo Simulation II and free energies Figure by MIT OCW. General Statistical Mechanics References D. Chandler, Introduction to Modern Statistical Mechanics D.A. McQuarrie,

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

Copyright 2001 University of Cambridge. Not to be quoted or copied without permission.

Copyright 2001 University of Cambridge. Not to be quoted or copied without permission. Course MP3 Lecture 4 13/11/2006 Monte Carlo method I An introduction to the use of the Monte Carlo method in materials modelling Dr James Elliott 4.1 Why Monte Carlo? The name derives from the association

More information

Density Functional Theory

Density Functional Theory Density Functional Theory Iain Bethune EPCC ibethune@epcc.ed.ac.uk Overview Background Classical Atomistic Simulation Essential Quantum Mechanics DFT: Approximations and Theory DFT: Implementation using

More information

André Schleife Department of Materials Science and Engineering

André Schleife Department of Materials Science and Engineering André Schleife Department of Materials Science and Engineering Length Scales (c) ICAMS: http://www.icams.de/cms/upload/01_home/01_research_at_icams/length_scales_1024x780.png Goals for today: Background

More information

Scientific Computing II

Scientific Computing II Scientific Computing II Molecular Dynamics Simulation Michael Bader SCCS Summer Term 2015 Molecular Dynamics Simulation, Summer Term 2015 1 Continuum Mechanics for Fluid Mechanics? Molecular Dynamics the

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

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

Classical Statistical Mechanics: Part 1

Classical Statistical Mechanics: Part 1 Classical Statistical Mechanics: Part 1 January 16, 2013 Classical Mechanics 1-Dimensional system with 1 particle of mass m Newton s equations of motion for position x(t) and momentum p(t): ẋ(t) dx p =

More information

510 Subject Index. Hamiltonian 33, 86, 88, 89 Hamilton operator 34, 164, 166

510 Subject Index. Hamiltonian 33, 86, 88, 89 Hamilton operator 34, 164, 166 Subject Index Ab-initio calculation 24, 122, 161. 165 Acentric factor 279, 338 Activity absolute 258, 295 coefficient 7 definition 7 Atom 23 Atomic units 93 Avogadro number 5, 92 Axilrod-Teller-forces

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

CE 530 Molecular Simulation

CE 530 Molecular Simulation 1 CE 530 Molecular Simulation Lecture 14 Molecular Models David A. Kofke Department of Chemical Engineering SUNY Buffalo kofke@eng.buffalo.edu 2 Review Monte Carlo ensemble averaging, no dynamics easy

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

Modeling & Simulation of Glass Structure

Modeling & Simulation of Glass Structure Modeling & Simulation of Glass Structure VCG Lecture 19 John Kieffer Department of Materials Science and Engineering University of Michigan 1 Overview Historical perspective Simulation methodologies Theoretical

More information

Analysis of the simulation

Analysis of the simulation Analysis of the simulation Marcus Elstner and Tomáš Kubař January 7, 2014 Thermodynamic properties time averages of thermodynamic quantites correspond to ensemble averages (ergodic theorem) some quantities

More information

Physics 4230 Final Examination 10 May 2007

Physics 4230 Final Examination 10 May 2007 Physics 43 Final Examination May 7 In each problem, be sure to give the reasoning for your answer and define any variables you create. If you use a general formula, state that formula clearly before manipulating

More information

Molecular Dynamics Simulation Study of Transport Properties of Diatomic Gases

Molecular Dynamics Simulation Study of Transport Properties of Diatomic Gases MD Simulation of Diatomic Gases Bull. Korean Chem. Soc. 14, Vol. 35, No. 1 357 http://dx.doi.org/1.51/bkcs.14.35.1.357 Molecular Dynamics Simulation Study of Transport Properties of Diatomic Gases Song

More information

Principles of Equilibrium Statistical Mechanics

Principles of Equilibrium Statistical Mechanics Debashish Chowdhury, Dietrich Stauffer Principles of Equilibrium Statistical Mechanics WILEY-VCH Weinheim New York Chichester Brisbane Singapore Toronto Table of Contents Part I: THERMOSTATICS 1 1 BASIC

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

Statistical methods in atomistic computer simulations

Statistical methods in atomistic computer simulations Statistical methods in atomistic computer simulations Prof. Michele Ceriotti, michele.ceriotti@epfl.ch This course gives an overview of simulation techniques that are useful for the computational modeling

More information

Computational Chemistry - MD Simulations

Computational Chemistry - MD Simulations Computational Chemistry - MD Simulations P. Ojeda-May pedro.ojeda-may@umu.se Department of Chemistry/HPC2N, Umeå University, 901 87, Sweden. May 2, 2017 Table of contents 1 Basics on MD simulations Accelerated

More information

G : Statistical Mechanics

G : Statistical Mechanics G25.2651: Statistical Mechanics Notes for Lecture 1 Defining statistical mechanics: Statistical Mechanics provies the connection between microscopic motion of individual atoms of matter and macroscopically

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

Modeling of Nanostructures and Materials Jacek A. Majewski Summer Semester 2013 Lecture 6 Lecture Modeling of Nanostructures Molecular Dynamics

Modeling of Nanostructures and Materials Jacek A. Majewski Summer Semester 2013 Lecture 6 Lecture Modeling of Nanostructures Molecular Dynamics Chair of Condensed Matter Physics nstitute of Theoretical Physics Faculty of Physics, Universityof Warsaw Summer Semester 013 Lecture Modeling of Nanostructures and Materials Jacek A. Majewski E-mail:

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

Basics of Statistical Mechanics

Basics of Statistical Mechanics Basics of Statistical Mechanics Review of ensembles Microcanonical, canonical, Maxwell-Boltzmann Constant pressure, temperature, volume, Thermodynamic limit Ergodicity (see online notes also) Reading assignment:

More information

Molecular Dynamics. Park City June 2005 Tully

Molecular Dynamics. Park City June 2005 Tully Molecular Dynamics John Lance Natasa Vinod Xiaosong Dufie Priya Sharani Hongzhi Group: August, 2004 Prelude: Classical Mechanics Newton s equations: F = ma = mq = p Force is the gradient of the potential:

More information

Monte Carlo. Lecture 15 4/9/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky

Monte Carlo. Lecture 15 4/9/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky Monte Carlo Lecture 15 4/9/18 1 Sampling with dynamics In Molecular Dynamics we simulate evolution of a system over time according to Newton s equations, conserving energy Averages (thermodynamic properties)

More information

Crossing the barriers - simulations of activated processes

Crossing the barriers - simulations of activated processes Crossing the barriers - simulations of activated processes Mgr. Ján Hreha for 6 th Student Colloquium and School on Mathematical Physics Faculty of Mathematics, Physics and Informatics Comenius University

More information

MatSci 331 Homework 4 Molecular Dynamics and Monte Carlo: Stress, heat capacity, quantum nuclear effects, and simulated annealing

MatSci 331 Homework 4 Molecular Dynamics and Monte Carlo: Stress, heat capacity, quantum nuclear effects, and simulated annealing MatSci 331 Homework 4 Molecular Dynamics and Monte Carlo: Stress, heat capacity, quantum nuclear effects, and simulated annealing Due Thursday Feb. 21 at 5pm in Durand 110. Evan Reed In this homework,

More information

Molecular Dynamics. Molecules in motion

Molecular Dynamics. Molecules in motion Molecular Dynamics Molecules in motion 1 Molecules in mo1on Molecules are not sta1c, but move all the 1me Source: h9p://en.wikipedia.org/wiki/kine1c_theory 2 Gasses, liquids and solids Gasses, liquids

More information

Structure of Cement Phases from ab initio Modeling Crystalline C-S-HC

Structure of Cement Phases from ab initio Modeling Crystalline C-S-HC Structure of Cement Phases from ab initio Modeling Crystalline C-S-HC Sergey V. Churakov sergey.churakov@psi.ch Paul Scherrer Institute Switzerland Cement Phase Composition C-S-H H Solid Solution Model

More information

Time reversible Born Oppenheimer molecular dynamics

Time reversible Born Oppenheimer molecular dynamics Time reversible Born Oppenheimer molecular dynamics Jianfeng Lu Mathematics Department Department of Physics Duke University jianfeng@math.duke.edu KI-Net Conference, CSCAMM, University of Maryland, May

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

(i) T, p, N Gibbs free energy G (ii) T, p, µ no thermodynamic potential, since T, p, µ are not independent of each other (iii) S, p, N Enthalpy H

(i) T, p, N Gibbs free energy G (ii) T, p, µ no thermodynamic potential, since T, p, µ are not independent of each other (iii) S, p, N Enthalpy H Solutions exam 2 roblem 1 a Which of those quantities defines a thermodynamic potential Why? 2 points i T, p, N Gibbs free energy G ii T, p, µ no thermodynamic potential, since T, p, µ are not independent

More information

Free Energy Estimation in Simulations

Free Energy Estimation in Simulations Physics 363/MatSE 38/ CSE 36 Free Energy Estimation in Simulations This is a brief overview of free energy estimation, much of which can be found in the article by D. Frenkel Free-Energy Computation and

More information

A Brief Introduction to Ab Initio Molecular Dynamics

A Brief Introduction to Ab Initio Molecular Dynamics A Brief Introduction to Ab Initio Molecular Dynamics Matt Probert Condensed Matter Dynamics Group, University of York, UK http://www.cmt.york.ac.uk/cmd http://www.castep.org Overview of Talk In this talk

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

fiziks Institute for NET/JRF, GATE, IIT-JAM, JEST, TIFR and GRE in PHYSICAL SCIENCES

fiziks Institute for NET/JRF, GATE, IIT-JAM, JEST, TIFR and GRE in PHYSICAL SCIENCES Content-Thermodynamics & Statistical Mechanics 1. Kinetic theory of gases..(1-13) 1.1 Basic assumption of kinetic theory 1.1.1 Pressure exerted by a gas 1.2 Gas Law for Ideal gases: 1.2.1 Boyle s Law 1.2.2

More information

Molecular dynamics simulation. CS/CME/BioE/Biophys/BMI 279 Oct. 5 and 10, 2017 Ron Dror

Molecular dynamics simulation. CS/CME/BioE/Biophys/BMI 279 Oct. 5 and 10, 2017 Ron Dror Molecular dynamics simulation CS/CME/BioE/Biophys/BMI 279 Oct. 5 and 10, 2017 Ron Dror 1 Outline Molecular dynamics (MD): The basic idea Equations of motion Key properties of MD simulations Sample applications

More information

A (short) practical introduction to kinetic theory and thermodynamic properties of gases through molecular dynamics

A (short) practical introduction to kinetic theory and thermodynamic properties of gases through molecular dynamics A (short) practical introduction to kinetic theory and thermodynamic properties of gases through molecular dynamics Miguel A. Caro mcaroba@gmail.com March 28, 2018 Contents 1 Preface 3 2 Review of thermodynamics

More information

FISES - Statistical Physics

FISES - Statistical Physics Coordinating unit: 230 - ETSETB - Barcelona School of Telecommunications Engineering Teaching unit: 748 - FIS - Department of Physics Academic year: Degree: 2018 BACHELOR'S DEGREE IN ENGINEERING PHYSICS

More information

List of Comprehensive Exams Topics

List of Comprehensive Exams Topics List of Comprehensive Exams Topics Mechanics 1. Basic Mechanics Newton s laws and conservation laws, the virial theorem 2. The Lagrangian and Hamiltonian Formalism The Lagrange formalism and the principle

More information

Wang-Landau Monte Carlo simulation. Aleš Vítek IT4I, VP3

Wang-Landau Monte Carlo simulation. Aleš Vítek IT4I, VP3 Wang-Landau Monte Carlo simulation Aleš Vítek IT4I, VP3 PART 1 Classical Monte Carlo Methods Outline 1. Statistical thermodynamics, ensembles 2. Numerical evaluation of integrals, crude Monte Carlo (MC)

More information

Simulation Methods II

Simulation Methods II Simulation Methods II Maria Fyta Institute for Computational Physics Universität Stuttgart Summer Term 2018 SM II - contents First principles methods Hartree-Fock and beyond Density-funtional-theory Ab

More information

THERMOSTATS AND THERMAL TRANSPORT IN SOLIDS

THERMOSTATS AND THERMAL TRANSPORT IN SOLIDS Hands-On Tutorial Workshop, July 19 th 2011 THERMOSTATS AND THERMAL TRANSPORT IN SOLIDS Christian Carbogno FRITZ-HABER-INSTITUT DER MAX-PLANCK-GESELLSCHAFT, BERLIN - GERMANY Hands-On Tutorial Workshop,

More information

Modifications of the Robert- Bonamy Formalism and Further Refinement Challenges

Modifications of the Robert- Bonamy Formalism and Further Refinement Challenges Modifications of the Robert- Bonamy Formalism and Further Refinement Challenges Q. Ma, NASA/GISS R. H. Tipping, Univ. of Alabama C. Boulet, Univ. Paris-Sud, France Statements The presentation is not a

More information

Random Walks A&T and F&S 3.1.2

Random Walks A&T and F&S 3.1.2 Random Walks A&T 110-123 and F&S 3.1.2 As we explained last time, it is very difficult to sample directly a general probability distribution. - If we sample from another distribution, the overlap will

More information

Using Molecular Dynamics to Compute Properties CHEM 430

Using Molecular Dynamics to Compute Properties CHEM 430 Using Molecular Dynamics to Compute Properties CHEM 43 Heat Capacity and Energy Fluctuations Running an MD Simulation Equilibration Phase Before data-collection and results can be analyzed the system

More information

Index. A Ab-initio, 8 Accomodation, 7 Accuracy, 37 hardware, 37 software, 37 Ackland, 36, 55, 157 Andersen, 44, 47 Austenite, 3

Index. A Ab-initio, 8 Accomodation, 7 Accuracy, 37 hardware, 37 software, 37 Ackland, 36, 55, 157 Andersen, 44, 47 Austenite, 3 Index A Ab-initio, 8 Accomodation, 7 Accuracy, 37 hardware, 37 software, 37 Ackland, 36, 55, 157 Andersen, 44, 47 Austenite, 3 B B2, 151 154, 156 Bain, 9, 10, 72, 73 parameters, 9 transformation, 9, 72

More information

Molecular Mechanics. I. Quantum mechanical treatment of molecular systems

Molecular Mechanics. I. Quantum mechanical treatment of molecular systems Molecular Mechanics I. Quantum mechanical treatment of molecular systems The first principle approach for describing the properties of molecules, including proteins, involves quantum mechanics. For example,

More information

Time-Dependent Statistical Mechanics 5. The classical atomic fluid, classical mechanics, and classical equilibrium statistical mechanics

Time-Dependent Statistical Mechanics 5. The classical atomic fluid, classical mechanics, and classical equilibrium statistical mechanics Time-Dependent Statistical Mechanics 5. The classical atomic fluid, classical mechanics, and classical equilibrium statistical mechanics c Hans C. Andersen October 1, 2009 While we know that in principle

More information

Statistical Mechanics

Statistical Mechanics Statistical Mechanics Newton's laws in principle tell us how anything works But in a system with many particles, the actual computations can become complicated. We will therefore be happy to get some 'average'

More information

Multiple time step Monte Carlo

Multiple time step Monte Carlo JOURNAL OF CHEMICAL PHYSICS VOLUME 117, NUMBER 18 8 NOVEMBER 2002 Multiple time step Monte Carlo Balázs Hetényi a) Department of Chemistry, Princeton University, Princeton, NJ 08544 and Department of Chemistry

More information

Chapter 4 Molecular Dynamics and Other Dynamics

Chapter 4 Molecular Dynamics and Other Dynamics Chapter 4 Molecular Dynamics and Other Dynamics Molecular dynamics is a method in which the motion of each individual atom or molecule is computed according to Newton s second law. It usually involves

More information

Lecture Models for heavy-ion collisions (Part III): transport models. SS2016: Dynamical models for relativistic heavy-ion collisions

Lecture Models for heavy-ion collisions (Part III): transport models. SS2016: Dynamical models for relativistic heavy-ion collisions Lecture Models for heavy-ion collisions (Part III: transport models SS06: Dynamical models for relativistic heavy-ion collisions Quantum mechanical description of the many-body system Dynamics of heavy-ion

More information

The electronic structure of materials 1

The electronic structure of materials 1 Quantum mechanics 2 - Lecture 9 December 18, 2013 1 An overview 2 Literature Contents 1 An overview 2 Literature Electronic ground state Ground state cohesive energy equilibrium crystal structure phase

More information

Ab-initio molecular dynamics: from the basics up to quantum effects Roberto Car Princeton University

Ab-initio molecular dynamics: from the basics up to quantum effects Roberto Car Princeton University Ab-initio molecular dynamics: from the basics up to quantum effects Roberto Car Princeton University Hands-on Tutorial Workshop on Ab-Initio Molecular Simulations, Fritz- Haber-Institut, Berlin, July 12-21,

More information

Electronic Structure Theory for Periodic Systems: The Concepts. Christian Ratsch

Electronic Structure Theory for Periodic Systems: The Concepts. Christian Ratsch Electronic Structure Theory for Periodic Systems: The Concepts Christian Ratsch Institute for Pure and Applied Mathematics and Department of Mathematics, UCLA Motivation There are 10 20 atoms in 1 mm 3

More information

Statistical Thermodynamics and Monte-Carlo Evgenii B. Rudnyi and Jan G. Korvink IMTEK Albert Ludwig University Freiburg, Germany

Statistical Thermodynamics and Monte-Carlo Evgenii B. Rudnyi and Jan G. Korvink IMTEK Albert Ludwig University Freiburg, Germany Statistical Thermodynamics and Monte-Carlo Evgenii B. Rudnyi and Jan G. Korvink IMTEK Albert Ludwig University Freiburg, Germany Preliminaries Learning Goals From Micro to Macro Statistical Mechanics (Statistical

More information

Rate of Heating and Cooling

Rate of Heating and Cooling Rate of Heating and Cooling 35 T [ o C] Example: Heating and cooling of Water E 30 Cooling S 25 Heating exponential decay 20 0 100 200 300 400 t [sec] Newton s Law of Cooling T S > T E : System S cools

More information

Ideal Gas Behavior. NC State University

Ideal Gas Behavior. NC State University Chemistry 331 Lecture 6 Ideal Gas Behavior NC State University Macroscopic variables P, T Pressure is a force per unit area (P= F/A) The force arises from the change in momentum as particles hit an object

More information

Thermal and Statistical Physics Department Exam Last updated November 4, L π

Thermal and Statistical Physics Department Exam Last updated November 4, L π Thermal and Statistical Physics Department Exam Last updated November 4, 013 1. a. Define the chemical potential µ. Show that two systems are in diffusive equilibrium if µ 1 =µ. You may start with F =

More information