Simulation of molecular systems by molecular dynamics

Size: px
Start display at page:

Download "Simulation of molecular systems by molecular dynamics"

Transcription

1 Simulation of molecular systems by molecular dynamics Yohann Moreau November 26, 2015 Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

2 Introduction MD is simulating the evolution of a system of particles along time. - Exploration of the PES: many configurations considered (static QM: only one per calculation) Dynamics algorithms are compatible with any method generating an energy in function of the geometry (non-born-oppenheimer dynamics is not considerd here). - MM QM or QM/MM MD - MM MD will be used for discussion here MD allows the calculation of thermodynamics values (free energy), statistical values (sampling), structural descriptors or study the evolution of a system along time. very important for biological systems (proteins) Few numerals - System containing up to 10 6 atoms - Simulation time from 10ps to 1µs (typically 100ns) Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

3 History : Work of Alder & Wainwright simulation of hard spheres (rare gases) 1974 : first simulation of liquid water by Stillinger & Rahman 1977 : first simulation of a protein (BPTI) by McCammon Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

4 Classical simulation methods: fundamental principles Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

5 Classical simulation methods: fundamental principles Basic Statements (for our short lecture) Use of classical mechanics, applied to a molecular system for which energy is a function of geometry - The motion of atoms is made classically (no TD-QM!) The principle is based on the second law of Newton: - The acceleration of a body is proportional to the net force felt by the body divided by its mass, or: i Fi = m a If one knows the forces 1 acting on all the particles at each time, one can calculate the acceleration and make the system evolve along time, using an integration scheme. Values calculated can be related to thermodynamics (internal, free, energies, etc.) 1 which derives from the potential: F = gradv Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

6 Classical simulation methods: fundamental principles Simulating the evolution of a system along time More than one particle: building the trajectory (integration of Newton s equations) is made numerically. The potential energy has to be computed at regular intervals every δt δt is the time step or integration step To switch from t to t + δt, forces are considered constant during δt δt has to be small enough to keep the total energy constant but should be as large as possible to simulate a longer time For a system with unconstrained X-H bonds, δt = s or 1 fs Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

7 Classical simulation methods: fundamental principles Integrating the Newton s equations of motion All algorithms consider that the geometry at t + δt can expressed as a Taylor series (with: v(t) = x (t) and a(t) = x (t)): x(t + δt) = x(t) + v(t)δt a(t)δt Hence, one must know the position x(t), velocities v(t) and forces via potential ( F = gradv ) at each t from the previous configuration Different algorithms: Verlet, Velocity Verlet,Leap-Frog, Runge-Kutta, Predictor-Corrector, Etc... Verlet and Leap-Frog are detailed hereafter Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

8 Classical simulation methods: fundamental principles The Verlet algorithm(1967, by Loup Verlet, born 1931) The 4 th order expansion of the position at (t + δt) and (t δt) are: x(t + δt) = x(t) + v(t)δt a(t)δt b(t)δt3 + O(δt 4 ) x(t δt) = x(t) v(t)δt a(t)δt2 1 6 b(t)δt3 + O(δt 4 ) In which the acceleration a(t) depends on forces: a(t + δt) = F (t+δt) m Summing them up leads to cancel the 1 st and 3 rd order terms: - The position at x(t + δt) can then be deduced: x(t + δt) = 2x(t) x(t δt) + a(t)δt 2 + O(δt 4 ) Velocities not needed; acceleration is known (derives from forces) Strength: easier and robust calculation but could be more precise Velocities derive from postions v(t) = x(t+δt) x(t δt) 2 t Also: Velocity-Verlet (equation 1 only, velocity is computed). Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

9 Classical simulation methods: fundamental principles The Leap-Frog algorithm Velocities of half steps are used ( at t + 1/2δt) : x(t + δt) = x(t) + v(t + 1/2δt)δt v(t + 1/2δt) = v(t 1/2δt) + a(t)δt Velocities and positions are computed every δt but shifted by 1/2δt - Eval. of positions leaps above the ones of velocities and vice-versa Strength: explicit calculation of velocities (precise) Drawback: velocities are not computed at the same time as positions and have to be approximated: v(t) = 1 2 [v(t 1/2δt) + v(t + 1/2δt)] Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

10 Classical simulation methods: fundamental principles Choice of the step size δt Must be small enough to avoid integration instabilities energy conservation (vide infra) Should be the largest possible to simulate a longer time within the same wallclock time The choice depends on the algorithm chosen and on the system The limit is related to the highest frequency of vibration: Example : ν XH s, δt should be 1/10 of it, hence 1fs max.. Fixing X-H bonds ( Shake algo. ) δt = 2fs is good. The wall clock time of calculation directly depends on δt Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

11 Few words about thermodynamics Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

12 Few words about thermodynamics Total, potential, kinetic energies, velocities and T For an isolated system, E tot (t) = E kin. (t) + E pot. (t) = constant E kin. (t) = i 1/2m iv 2 i (t) Equipartition of energy implies E kin. = 3/2Nk b T With a large enough sampling, one can estimate T At the beginning of a simulation, individual velocities of each particle is given following a Maxwell-Boltzmann distribution with p(v ix ) the probability for atom i to have a velocity of v ix : p(v ix ) = ( mi 2πk b T ) 1 2 exp ( m i v ix 2k b T Moreover, the total momentum should be zero ( flying ice cube ) p = i p i = i m iv i = 0 ) Temperature can be kept constant in a simulation with a thermostat : - Berendsen (periodic rescaling of velocities), Nosé-Hoover Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

13 Few words about thermodynamics Pressure and Volume Starting from the virial theorem, pressure and volume can be related The total virial is the sum of an ideal gas part and an contribution due to interactions between particles Skipping theory, pressure is related to volume via: P = 1 Nk B T 1 N N r ij f ij V 3k B T i=1 j=1+1 - r ij is the distance between particles i and j (computed) - f ij is the force acting between particles i and j (computed too) Pressure kept constant by adjusting the volume of the simulation cell If volume is kept constant, pression has ro fluctuate Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

14 Few words about thermodynamics Thermodynamic ensembles A system can be simulated under different conditions: - The common ensembles are named using fixed quantities: NVE (microcanonical) : - isolated system in a periodic cell with a fixed volume NVT (canonical) : - system in a periodic cell of fixed volume, coupled to a thermostat NPT : - barostatic and thermostatic system: the volume of the simulation cell can vary µpt/µvt (grand canonical): - the chemical potential is fixed, the nb. of particles can vary Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

15 Few words about thermodynamics The ergodic hyopthesis, simulation time Experimentally, an obsevable A corresponds to an average over a large number of replicas of the system taken simultaneously With MD, we study a single system, which makes impossible to calculate an ensemble average The ergodic hypothesis states that the ensemble average is equal to the time average: A ensemble = A time By allowing the system to evolve indefinitely, it will eventually pass through all the possible states. - Experimentally relevant informations (structure, thermodynamics) can the be calculated. Practically, simulations have to be long enough to generate enough representative configurations Typical simulation time: 1 to more than 100 ns. Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

16 Periodic Boudnary Conditions and long range interactions Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

17 Periodic Boudnary Conditions and long range interactions Periodic Boundary Conditions: principles Goal: simulating a system without boundary effects The opposite sides of the simulation cell (box) are joined 2 A particle (or an interaction!) that exits on the right enters on the left In order to avoid the self-interaction of a molecule with its image one uses the minimum-image convention: Interactions are truncated beyond a distance lower or equal to the half the cell parameter (box size) Constraints: All the sides must be joined (i.e. the replication of the cell must fill the space without empty space) The size of the box must be large enough so that interaction truncation is made at a long distance Better to keep the simulation box electrically neutral (compulsory for Particle-Mesh-Ewald) 2 pacman Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

18 Periodic Boudnary Conditions and long range interactions PBC and minumum-image convention: illustration in 2D Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

19 Periodic Boudnary Conditions and long range interactions Dealing with long range interactions Non bonded terms: Van der Waals and electrostatic Have to cancel according to PBC and the minimum image convention Different ways to apply a cutoff distance 3 : - Set to zero abruptly beyond a given distance (not shown) - Smooth bias between a switching distance and the cutoff (preferred) - shift the whole potential to be zero at the good distance and beyond. 3 picture from K. Shulten s website Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

20 Periodic Boudnary Conditions and long range interactions Ewald Summations for electrostatics (not detailed) Because electrostatic interactions are long ranged, they are likely to extend outside the box one way to work around is to split the description using Ewald summation (not detailed here) Practically: - a short-range term for direct interactions (every step) - a long-range term, computed as for periodic systems not every step Calculation is made in the inverse space (like in solids) Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

21 How to conduct an MD simulation? (Example of proteins) Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

22 How to conduct an MD simulation? Step one: Generate a starting system of good quality 1 Get (or build) the geometry of a system (from the PDB, e.g.) - Rebuild the structure (some amino-acids may be missing) - Structure from X-Ray: hydrogens have to be added! - Correctly protonate the titrable residues (ASP, HIS, ASP, etc.) Minimization of the structure for added atoms 2 Addition of the environment (solvent, lipidic bi-layer) Often: superimposition of a water box with the protein, deletion of water overlaping with protein Minimization of solvent molecules The size of the simulation box is fixed for PBC 3 Counter-ions are added in the solvent to nuetralize the whole system Na + or Cl are used in general Minimization of the solvent and ions Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

23 How to conduct an MD simulation? 2- Dynamical treatment of the system 1 Gradual heating of the system by slow increase of velocities Example: 30ps of heating from 0 à 300K by steps of 10K every 0.1 ps (every 100 steps of 1fs) 2 After heating the system, the MD simulation can be started Phase 1 : Equilibration of the system Goal: Assess the stability (energy, structure) of the system The length of equilibration is in function of the size of hte system Phase 2 : Production After equilibration, positions and velocities are savec relgularly to compute quantities afterward Remark : Since each point of the trajectory depends on the previous only, it is possible to restart an MD without redoing all the previous calculations (positions and forces must be available) Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

24 How to conduct an MD simulation? Trajectory anlaysis and computable properties All properties not implying chemical reactivity Statistical and or structural properties: Radial distribution function (average nb. of first neighbors), heat of vaporization, etc. Dynamic properties: diffusion constants Evolution of the structure of a system: (un)folding of (small) proteins Free energy profile of a transformation To constraint the dynamics some constraints and/or restraints can be added See next part for examples of computed properties Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

25 Other methods related to Classical Molecular Dynamics Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

26 Other methods related to Classical Molecular Dynamics Different possibilities Intrinsically, every system is dynamic (T > 0 K) 1 Born-Oppenheimer MD an a QM or QM/MM PES Allows to simulate of the evolution of the electronic structure (reactivity) - Software: CP2K 2 Dynamics made by propagating elecgronic degrees of freedom Carr-Parinello (CPMD) Atomic Density Matrix Propagation (ADMP : Gaussian) 3 Meta-dynamics Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

27 Other methods related to Classical Molecular Dynamics Metropolis Monte-Carlo: a random-based approach Instead of building a trajectory, with each point depending on the previous, random configurations are ganarated. Usually, config. n is generated by a random change to config. n 1 Needs a smart algorithm to modify the structure of the system 1 Strength: only energy is evaluated, no need to integrate equations of motion or evaluate velocities - fast many points can be generated 2 Drawback: Not all the configs generated are kept (some are discarded) Discarding test: Metropolis (Boltzmann criterion) 3 Complex: How to choose the way to modify the system? The algorithm must give an unbiased statistical sampling 4 A Metropolis-MC simulation naturally generates ans NVT ensemble - But other ensembles are possible Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

28 Other methods related to Classical Molecular Dynamics Flowchart for a Metropolis Monte-Carlo simulation Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

29 Simulations Results: computing properties of a system Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

30 Simulations Results: computing properties of a system Visual analysis of the result, with VMD, e.g. Helpful to understand and describe some phenomena - How a protein unfolds e.g. Example: Oil and water separation by molecular dynamics simulation - Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

31 Simulations Results: computing properties of a system Energetic Properties Energy - Average energy: < E >= 1 N N i=1 E i - Total energy (terms) along time - With a force field, one can separate the different components: the average value for different energies can be calcualted - Total energy, bonding energies, etc... heat capacity at constant volume is the variation of internal energy U with respect to temperature : C v = ( ) U T V in an NVT ensembe, it can be computed as: C v = 1 (U U m kt 2 ) 2 = 1 ( U 2 ) kt 2 M U 2 M Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

32 Simulations Results: computing properties of a system Structural properties: The Radial Distribution Function (RDF) Example : the O-O RDF for three models of water (Jorgensen et al. 1979) The maximum of a peak gives the average distance of a solvation shell Integral under the peak yields to the number of molecules in the associated shell Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

33 Simulations Results: computing properties of a system Structural properties: How mobile a structure is RMSD : Root Mean Square Deviation - RMSD compared to a given state in function of time 1 - rmsd(t) = n n i=1 r i(t) r i (0) 2 Allows to quantify the variation of global geometry along simulation time - Can be made on the whole system or on a part of it (not on solvent) RMSF : Root Mean Square Fluctuation - Variation of the position of a particle around a given position or in a given state 1 - rmsf (i) = T T t=1 r i(t) r(av.) i 2 Allows to determine which atoms move the most Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

34 Simulations Results: computing properties of a system Dynamic quantities based on the time correlation function: Correlation of two quantities along time: - C AB (t) =< A(t).B(0) > quantities can be individual or collective - C AA (t) =< A(t).A(0) >: autocorrelation function of quantity A. An autocorrelation function measures how a variable is correlated with its initial value along time. -at t=0, C=1; at t, C=0 The Fourier transform of some autocorrelation functions can be related to spectroscopic data! Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

35 Simulations Results: computing properties of a system Dynamic quantities based on the time correlation function: Diffusion coefficient as the integral of velocities autocorrelation functions : D = V (t).v (0) dt The Fourier transform of the total dipole moment autocorrealtion function (with some factors) can be used to obtain the IR spectrum I (ω) of the system: I (ω) = α(ω)n(ω) = 2πω ( 1 e βhω) 3hcV + dt M(t). M(0) e iωt - Good for intensities, less good for positions of peaks - Recent works by Gaigeot et al. using QM and QM/MM MD Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, / 35

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

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

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

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

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

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

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

Computer simulation methods (2) Dr. Vania Calandrini

Computer simulation methods (2) Dr. Vania Calandrini Computer simulation methods (2) Dr. Vania Calandrini in the previous lecture: time average versus ensemble average MC versus MD simulations equipartition theorem (=> computing T) virial theorem (=> computing

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

Biomolecular modeling II

Biomolecular modeling II 2015, December 16 System boundary and the solvent Biomolecule in solution typical MD simulations molecular system in aqueous solution task make the system as small as possible (reduce cost) straightforward

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

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

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

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

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

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

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

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

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

Advanced sampling. fluids of strongly orientation-dependent interactions (e.g., dipoles, hydrogen bonds)

Advanced sampling. fluids of strongly orientation-dependent interactions (e.g., dipoles, hydrogen bonds) Advanced sampling ChE210D Today's lecture: methods for facilitating equilibration and sampling in complex, frustrated, or slow-evolving systems Difficult-to-simulate systems Practically speaking, one is

More information

Hands-on : Model Potential Molecular Dynamics

Hands-on : Model Potential Molecular Dynamics Hands-on : Model Potential Molecular Dynamics OUTLINE 0. DL_POLY code introduction 0.a Input files 1. THF solvent molecule 1.a Geometry optimization 1.b NVE/NVT dynamics 2. Liquid THF 2.a Equilibration

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

Molecular Dynamics 9/6/16

Molecular Dynamics 9/6/16 Molecular Dynamics What to choose in an integrator The Verlet algorithm Boundary Conditions in Space and time Reading Assignment: Lesar Chpt 6, F&S Chpt 4 1 The Molecular Dynamics (MD) method for classical

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

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

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

Computer simulation methods (1) Dr. Vania Calandrini

Computer simulation methods (1) Dr. Vania Calandrini Computer simulation methods (1) Dr. Vania Calandrini Why computational methods To understand and predict the properties of complex systems (many degrees of freedom): liquids, solids, adsorption of molecules

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

Molecular Mechanics. Yohann Moreau. November 26, 2015

Molecular Mechanics. Yohann Moreau. November 26, 2015 Molecular Mechanics Yohann Moreau yohann.moreau@ujf-grenoble.fr November 26, 2015 Yohann Moreau (UJF) Molecular Mechanics, Label RFCT 2015 November 26, 2015 1 / 29 Introduction A so-called Force-Field

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

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

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

Advanced Molecular Molecular Dynamics

Advanced Molecular Molecular Dynamics Advanced Molecular Molecular Dynamics Technical details May 12, 2014 Integration of harmonic oscillator r m period = 2 k k and the temperature T determine the sampling of x (here T is related with v 0

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

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

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

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

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

Exercise 2: Solvating the Structure Before you continue, follow these steps: Setting up Periodic Boundary Conditions

Exercise 2: Solvating the Structure Before you continue, follow these steps: Setting up Periodic Boundary Conditions Exercise 2: Solvating the Structure HyperChem lets you place a molecular system in a periodic box of water molecules to simulate behavior in aqueous solution, as in a biological system. In this exercise,

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

Force Field for Water Based on Neural Network

Force Field for Water Based on Neural Network Force Field for Water Based on Neural Network Hao Wang Department of Chemistry, Duke University, Durham, NC 27708, USA Weitao Yang* Department of Chemistry, Duke University, Durham, NC 27708, USA Department

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

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

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

Potential Energy (hyper)surface

Potential Energy (hyper)surface 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

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

Non-bonded interactions

Non-bonded interactions speeding up the number-crunching continued Marcus Elstner and Tomáš Kubař December 3, 2013 why care? number of individual pair-wise interactions bonded interactions proportional to N: O(N) non-bonded interactions

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

Viscous Flow Computations with Molecular Dynamics

Viscous Flow Computations with Molecular Dynamics FAKULTÄT FÜR INFORMATIK DER TECHNISCHEN UNIVERSITÄT MÜNCHEN Bachelorarbeit in Informatik Viscous Flow Computations with Molecular Dynamics Ching-Yu Kao FAKULTÄT FÜR INFORMATIK DER TECHNISCHEN UNIVERSITÄT

More information

Supporting Information Soft Nanoparticles: Nano Ionic Networks of Associated Ionic Polymers

Supporting Information Soft Nanoparticles: Nano Ionic Networks of Associated Ionic Polymers Electronic Supplementary Material (ESI) for Nanoscale. This journal is The Royal Society of Chemistry 2016 Supporting Information Soft Nanoparticles: Nano Ionic Networks of Associated Ionic Polymers Dipak

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

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

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

SIMCON - Computer Simulation of Condensed Matter

SIMCON - Computer Simulation of Condensed Matter Coordinating unit: 230 - ETSETB - Barcelona School of Telecommunications Engineering Teaching unit: 748 - FIS - Department of Physics Academic year: Degree: 2017 BACHELOR'S DEGREE IN ENGINEERING PHYSICS

More information

Non-bonded interactions

Non-bonded interactions speeding up the number-crunching Marcus Elstner and Tomáš Kubař May 8, 2015 why care? key to understand biomolecular structure and function binding of a ligand efficiency of a reaction color of a chromophore

More information

Molecular Dynamics. What to choose in an integrator The Verlet algorithm Boundary Conditions in Space and time Reading Assignment: F&S Chapter 4

Molecular Dynamics. What to choose in an integrator The Verlet algorithm Boundary Conditions in Space and time Reading Assignment: F&S Chapter 4 Molecular Dynamics What to choose in an integrator The Verlet algorithm Boundary Conditions in Space and time Reading Assignment: F&S Chapter 4 MSE485/PHY466/CSE485 1 The Molecular Dynamics (MD) method

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

1. Thermodynamics 1.1. A macroscopic view of matter

1. Thermodynamics 1.1. A macroscopic view of matter 1. Thermodynamics 1.1. A macroscopic view of matter Intensive: independent of the amount of substance, e.g. temperature,pressure. Extensive: depends on the amount of substance, e.g. internal energy, enthalpy.

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

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

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

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

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

Atoms, electrons and Solids

Atoms, electrons and Solids Atoms, electrons and Solids Shell model of an atom negative electron orbiting a positive nucleus QM tells that to minimize total energy the electrons fill up shells. Each orbit in a shell has a specific

More information

Statistical thermodynamics for MD and MC simulations

Statistical thermodynamics for MD and MC simulations Statistical thermodynamics for MD and MC simulations knowing 2 atoms and wishing to know 10 23 of them Marcus Elstner and Tomáš Kubař 22 June 2016 Introduction Thermodynamic properties of molecular systems

More information

Monte Carlo (MC) Simulation Methods. Elisa Fadda

Monte Carlo (MC) Simulation Methods. Elisa Fadda Monte Carlo (MC) Simulation Methods Elisa Fadda 1011-CH328, Molecular Modelling & Drug Design 2011 Experimental Observables A system observable is a property of the system state. The system state i is

More information

Energy Landscapes and Accelerated Molecular- Dynamical Techniques for the Study of Protein Folding

Energy Landscapes and Accelerated Molecular- Dynamical Techniques for the Study of Protein Folding Energy Landscapes and Accelerated Molecular- Dynamical Techniques for the Study of Protein Folding John K. Prentice Boulder, CO BioMed Seminar University of New Mexico Physics and Astronomy Department

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

Ordinary differential equations. Phys 420/580 Lecture 8

Ordinary differential equations. Phys 420/580 Lecture 8 Ordinary differential equations Phys 420/580 Lecture 8 Most physical laws are expressed as differential equations These come in three flavours: initial-value problems boundary-value problems eigenvalue

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

Analysis of MD trajectories in GROMACS David van der Spoel

Analysis of MD trajectories in GROMACS David van der Spoel Analysis of MD trajectories in GROMACS David van der Spoel What does MD produce? Energy terms E(t) Coordinates x(t) Velocities v(t) Forces f(t) Managing your files trjcat - merging trajectories concatenating

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

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

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

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

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

Statistical Mechanics & Simulations

Statistical Mechanics & Simulations Jean-Christophe SOETENS Department of Chemistry University of Bordeaux jean-christophe.soetens@u-bordeaux.fr Academic year 2017-2018 Academic year 2017-2018 1 Organization Where? Here A10 Lavoisier room

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

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

Biomolecular modeling I

Biomolecular modeling I 2016, December 6 Biomolecular structure Structural elements of life Biomolecules proteins, nucleic acids, lipids, carbohydrates... Biomolecular structure Biomolecules biomolecular complexes aggregates...

More information

Multiscale Materials Modeling

Multiscale Materials Modeling Multiscale Materials Modeling Lecture 09 Quantum Mechanics/Molecular Mechanics (QM/MM) Techniques Fundamentals of Sustainable Technology These notes created by David Keffer, University of Tennessee, Knoxville,

More information

Choosing weights for simulated tempering

Choosing weights for simulated tempering PHYSICAL REVIEW E 7, 173 7 Choosing weights for simulated tempering Sanghyun Park 1 and Vijay S. Pande 1, 1 Department of Chemistry, Stanford University, Stanford, California 935, USA Department of Structural

More information

The Molecular Dynamics Method

The Molecular Dynamics Method H-bond energy (kcal/mol) - 4.0 The Molecular Dynamics Method Fibronectin III_1, a mechanical protein that glues cells together in wound healing and in preventing tumor metastasis 0 ATPase, a molecular

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

Tailoring the Properties of Quadruplex Nucleobases for Biological and Nanomaterial Applications

Tailoring the Properties of Quadruplex Nucleobases for Biological and Nanomaterial Applications Electronic Supplementary Material (ESI) for Physical Chemistry Chemical Physics. This journal is the Owner Societies 2014 Supporting Information for: Tailoring the Properties of Quadruplex Nucleobases

More information

Heat Transport in Glass-Forming Liquids

Heat Transport in Glass-Forming Liquids Heat Transport in Glass-Forming Liquids by VINAY VAIBHAV The Institute of Mathematical Sciences CIT Campus, Taramani, Chennai 600 113, India. A thesis submitted in partial fulfillment of requirements for

More information

Can a continuum solvent model reproduce the free energy landscape of a β-hairpin folding in water?

Can a continuum solvent model reproduce the free energy landscape of a β-hairpin folding in water? Can a continuum solvent model reproduce the free energy landscape of a β-hairpin folding in water? Ruhong Zhou 1 and Bruce J. Berne 2 1 IBM Thomas J. Watson Research Center; and 2 Department of Chemistry,

More information

Scientific Computing II

Scientific Computing II Scientific Computing II Molecular Dynamics Numerics Michael Bader SCCS Technical University of Munich Summer 018 Recall: Molecular Dynamics System of ODEs resulting force acting on a molecule: F i = j

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

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

Modeling & Simulation of Glass Structure

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

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

1 Introduction to Molecular Dynamics

1 Introduction to Molecular Dynamics 1 Introduction to Molecular Dynamics Ralf Schneider, Amit Raj Sharma, and Abha Rai Max-Planck-Institut für Plasmaphysik, Teilinstitut Greifswald, 17491 Greifswald, Germany Molecular dynamics is the science

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

Theoretical models for the solvent effect

Theoretical models for the solvent effect Theoretical models for the solvent effect Benedetta Mennucci Dipartimento di Chimica e Chimica Industriale Web: http://benedetta.dcci.unipi.it Email: bene@dcci.unipi.it 8. Excited electronic states in

More information

Part II Statistical Physics

Part II Statistical Physics Part II Statistical Physics Theorems Based on lectures by H. S. Reall Notes taken by Dexter Chua Lent 2017 These notes are not endorsed by the lecturers, and I have modified them (often significantly)

More information