Energy and Forces in DFT

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

Ab initio molecular dynamics

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

Ab initio molecular dynamics: Basic Theory and Advanced Met

Ab initio Molecular Dynamics Born Oppenheimer and beyond

Ab initio molecular dynamics and nuclear quantum effects

Time reversible Born Oppenheimer molecular dynamics

Accelerated Quantum Molecular Dynamics

Ab initio molecular dynamics : BO

Next generation extended Lagrangian first principles molecular dynamics

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

What is Classical Molecular Dynamics?

Molecular Dynamics Simulations

Javier Junquera. Statistical mechanics

Computer simulation methods (1) Dr. Vania Calandrini

Introduction Statistical Thermodynamics. Monday, January 6, 14

Statistical Mechanics. Atomistic view of Materials

Ab initio Molecular Dynamics

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

Gear methods I + 1/18


Ab Initio Molecular Dynamic

Analysis of MD Results Using Statistical Mechanics Methods. Molecular Modeling

Density Functional Theory: from theory to Applications

First-principles Molecular Dynamics Simulations

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

A Brief Introduction to Statistical Mechanics

Ab Initio Molecular Dynamic

Molecular Dynamics. Park City June 2005 Tully

1. Thermodynamics 1.1. A macroscopic view of matter

Classical Molecular Dynamics

CHE3935. Lecture 4 Quantum Mechanical Simulation Methods Continued

Density Functional Theory: from theory to Applications

G : Statistical Mechanics

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

Temperature and Pressure Controls

Enabling constant pressure hybrid Monte Carlo simulations using the GROMACS molecular simulation package

Algorithms and Computational Aspects of DFT Calculations

Quantum Molecular Dynamics Basics

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

Temperature and Pressure Controls

Fast Eigenvalue Solutions

Langevin Dynamics in Constant Pressure Extended Systems

I. BASICS OF STATISTICAL MECHANICS AND QUANTUM MECHANICS

Introduction to molecular dynamics

Microcanonical Ensemble

Ab initio molecular dynamics: Propagating the density matrix with Gaussian orbitals

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

2. Thermodynamics. Introduction. Understanding Molecular Simulation

Before we start: Important setup of your Computer

Simulation of molecular systems by molecular dynamics

Computational Physics

REVIEW. Hamilton s principle. based on FW-18. Variational statement of mechanics: (for conservative forces) action Equivalent to Newton s laws!

Introduction to DFTB. Marcus Elstner. July 28, 2006

Basic tutorial to CPMD calculations

Car-Parrinello Molecular Dynamics

N independent electrons in a volume V (assuming periodic boundary conditions) I] The system 3 V = ( ) k ( ) i k k k 1/2

Introduction to atomic scale simulations

Introduction to density functional perturbation theory for lattice dynamics

Statistical thermodynamics for MD and MC simulations

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

III. Kinetic Theory of Gases

Crossing the barriers - simulations of activated processes

Physics 342 Lecture 27. Spin. Lecture 27. Physics 342 Quantum Mechanics I

CONTACT PROPERTIES OF HYDRATED SILICA SURFACES

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

Physics 5153 Classical Mechanics. Canonical Transformations-1

Molecular dynamics: Car-Parrinello method

Computational Chemistry - MD Simulations

Lecture 16 March 29, 2010

Free energy calculations and the potential of mean force

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

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

arxiv: v1 [physics.comp-ph] 22 Oct 2015

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

Nanoscale simulation lectures Statistical Mechanics

summary of statistical physics

2. The Schrödinger equation for one-particle problems. 5. Atoms and the periodic table of chemical elements

Molecular dynamics simulation of Aquaporin-1. 4 nm

Lectures on basic plasma physics: Hamiltonian mechanics of charged particle motion

Molecular dynamics simulations

QUANTUM AND THERMAL MOTION IN MOLECULES FROM FIRST-PRINCIPLES

An Approximate DFT Method: The Density-Functional Tight-Binding (DFTB) Method

Excitation Dynamics in Quantum Dots. Oleg Prezhdo U. Washington, Seattle

v(r i r j ) = h(r i )+ 1 N

Newtonian and extended Lagrangian dynamics

Non Adiabatic Transitions in a Simple Born Oppenheimer Scattering System

Modified Ehrenfest formalism: A new approach for large scale ab-initio molecular dynamics

MP203 Statistical and Thermal Physics. Jon-Ivar Skullerud and James Smith

Second quantization: where quantization and particles come from?

Conical Intersections. Spiridoula Matsika

Modeling Materials. Continuum, Atomistic and Multiscale Techniques. gg CAMBRIDGE ^0 TADMOR ELLAD B. HHHHM. University of Minnesota, USA

Optimization with Surrogates for Electronic-Structure Calculations. Yonas Beyene Abraham

Hierarchical Multiscale Modeling of Materials: an Application to Microporous Systems

ChE 210B: Advanced Topics in Equilibrium Statistical Mechanics

CE 530 Molecular Simulation

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

Part II Statistical Physics

Intro to ab initio methods

Introduction to model potential Molecular Dynamics A3hourcourseatICTP

Transcription:

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 n(r) Hellmann-Feynman forces: F i = de = dr i V (r) n(r) dr E II (2) R i R i where V {R} = external potential acting on electrons

DFT and Molecular Dynamics Let us assume i) classical nuclei, ii) electrons in the ground state. We can introduce a classical Lagrangian: L = 1 2 i M i Ṙ 2 i E tot ({R}) (3) describing the motion of nuclei. Equations of motion: d L dt Ṙi L R i = 0, P i = L Ṙi (4) are nothing but usual Newton s equations: P i M i V i, M i V i = F i (5)

Discretization of the equation of motion Verlet algorithm: Velocity Verlet: R i (t + δt) = 2R i (t) R i (t δt) + δt2 M i F i (t) + O(δt 4 ) (6) V i (t) = 1 2δt [R i(t + δt) R i (t δt)] + O(δt 3 ). (7) V i (t + δt) = V i (t) + δt 2M i [F i (t) + F i (t + δt)] (8) R i (t + δt) = R i (t) + δtv i (t) + δt2 2M i F i (t). (9) Both sample the microcanonical ensemble, or NVE: the energy is conserved.

Thermodynamical averages Averages (ρ = probability of a microscopic state): A = ρ(r, P)A(R, P)dRdP (10) are usually well approximated by averages over time: and the latter by discrete average over a trajectory: lim A T A (11) T A T = 1 T T 0 A(R(t), P(t))dt 1 M M n=1 A(t n ), t n = nδt, t M = Mδt = T. (12)

Costant-Temperature and constant-pressure dynamics Molecular Dynamics with Nosé Thermostats samples the canonical ensemble (NVT): the average temperature is fixed N i=1 P 2 i 2M i NV T = 3 2 Nk BT (13) Molecular Dynamics with variable cell samples the NPT ensemble: the average pressure is fixed In both cases, additional (fictitious) degrees of freedom are considered

Technicalities time step as big as possible, but small enough to follow nuclear motion with little loss of accuracy. Rule of thumb: δt 0.01 0.1δt max, where δt max = 1/ω max = period of the fastest phonon mode. calculations of forces must be very accurate at each time step (good self-consistency needed) or else a systematic energy drift will appear Note that: error for DFT energy is quadratic in the SCF error of the charge density error for DFT forces is linear in the SCF error of the charge density

Car-Parrinello Molecular Dynamics The idea: introduce a (fictitious) electron dynamics that keeps the electrons close to the ground state the electron dynamics is faster than the nuclear dynamics and averages out the error......but not too fast so that a reasonable time step can be used Very simple and effective! All classical MD technology can be used Requires a judicious choice of simulation parameters

Car-Parrinello Lagrangian L = µ dr 2 ψ k (r) 2 + 1 M i Ṙ 2 i E tot ({R}, {ψ}) 2 k i + ( ) Λ kl ψk(r)ψ l (r)dr δ kl k,l (14) generates equations of motion: µ ψ k = Hψ k l Λ kl ψ l, M i Ri = E tot R i (15) µ = fictitious electronic mass Λ kl = Lagrange multipliers enforce orthonormality constraints.

Car-Parrinello Lagrangian (2) electronic degrees of freedom ψ k orbitals into PW are the expansion coefficients of KS forces on electrons are determined by the KS Hamiltonian calculated from current values of ψ k and of R i forces acting on nuclei have the Hellmann-Feynman form: E tot R i = k ψ k V R i ψ k (16) but they slightly differ from true forces

Car-Parrinello technicalities Starting point: bring the electrons to the ground state at fixed ions The simulation is performed using classical MD technology (Verlet) on both nuclear positions and electronic degrees of freedom Orthonormality constraints are exactly imposed at each time step, using an iterative procedure The choice of parameters (fictitious electronic mass µ and time step δt) must ensure that there is no energy transfer from nuclei to electrons, i.e. the kinetic energy of the electronic degrees of freedom does not systematically increase

Choice of the parameters The fictitious electronic mass µ and time step δt must be chosen in such a way that: µ is be big enough to enable the use of a reasonable time step, small enough to guarantee adiabaticity, i.e. no energy transfer from nuclei to electrons, which always remain close to the ground state correctness of the nuclear trajectory Typical values: 100 400 electron masses δt should be the largest value that yields a stable dynamics (no drifts, no loss of orthonormality)

Why Car-Parrinello works The CP dynamics is classical, both for nuclei and electrons: the energy should equipartition! Typical frequencies associated to electron dynamics: ω el (ɛ i ɛ j )/µ. if there is a gap in the electronic spectrum, ω el min ɛ gap /µ Typical frequencies associated to nuclear dynamics: phonon frequencies ω ph If ω ph max << ω el min there is negligible energy transfer from nuclei to electrons A fast electron dynamics keeps the electrons close to the ground state and averages out the error on the forces. The slow nuclear dynamics is very close to the correct one, i.e. with electrons in the ground state. (Pastore, Smargiassi, Buda, PRA 44, 6334, 1991).