1.021 , 3.021, 10.333, 22.00 I ntroduc tion to Modeling and Simulation Part I – C ontinuum and partic le me thods
Review session—preparation quiz I
Lecture 12
Markus J. Buehler
1
Laboratory for Atomistic and Molecular Mechanics Department of Civil and Environmental Engineering Massachusetts Institute of Technology
Content overview
I. Particle and continuum me thods
1. Atoms, molecul e s, chemistry
2. Continuum modeling approac hes and solution approaches
3. Statistical mechanics
4. Molecular dynamics, Monte Carlo
5. Visualization and data analysis
6. Mechanical proper ties – applic ation: how things fail (and how to prevent it)
7. Multi-scale modeling par adigm
8. Biological systems (simulation in biophysics) – h ow proteins work and how to model them
II. Quantum mechanical methods
1. It’s A Q uantum World: T he Theory of Quantum Mechanics
2. Quantum Mechanics: Practice Makes Perfect
3. The Many-Body Problem: Fr om Many-Body to Single- Particle
4. Quantum modeling of materials
5. From Atoms to Solids
6. Basic pr operties of mater i als
7. Advanced proper ties of materials
8. What else can we do?
Lectures 2-13
Lectures 14-26
2
Overview: Material covered so far…
Lecture 1: B road introduction to IM/S
Lecture 2 : Introduction t o atomistic and conti nuum modeling (mult i-scale modeling paradigm, difference between continuum and atomis tic approach, case study: diffusion)
Lecture 3 : Basic statistical mechani cs – p roperty calculation I (property calculati o n: microscopic states vs. macroscopic proper ties, ensembl es, probabi lity density and partiti o n function)
Lecture 4 : Prope rty calculation II (Monte Carl o, advanced property ca lcu l ati o n, introd uctio n to chemical interacti ons)
Lecture 5: How to model chemic al intera ctions I (exampl e: movi e of copper deformation/disl ocations, etc.)
Lecture 6: How to model ch emic al intera ctions II (EAM, a bit of ReaxFF—chemical reacti ons)
Lecture 7: Appli cation to mo del i ng brittle materials I
Lecture 8: Appli cation to mo del i ng brittle materials II
Lecture 9: Appli cation – A pplications to materials failure
Lecture 10: Appl ications to bi ophysics an d bi onanomechanics
Lecture 11: Appl ications to bi oph ysics an d bi onanomechanics (cont’ d)
3
Lecture 12: Review session – p art I
Check: goals of part I
You will be able to …
Carry out atomistic simulations of various processes (diffusion, deformation/stre tching, materials failure)
Carbon nanotubes, nanowires, bu lk metals, proteins, silicon crystals, …
Analyze atomistic simulations
Visualize atomistic/molecular data
Understand how to link atomistic simulation results with continuum models within a multi-scale scheme
Potential/ force field models
Applications
Topics covered – part I
Atomistic & molec u lar simulation algorithms
Property calculation
Lecture 12: Review session – p art I
1. Review of material covered in part I
1.1 Atomistic and molecular simulation algorithms
1.2 Property calculation
1.3 Potential/force field models
1.4 Applications
2. Important terminology and concepts
Goal of today’s lecture:
Review main concepts of atomistic and molecular dynamics, continuum models
Prepare you for the quiz on Thursday
1.1 Atomistic and molecular simulation algorithms
1.2 Property calculation
1.3 Potential/force field models
1.4 Applications
Goals: Basic MD algorithm (integrat ion scheme), initial/boundary conditions, numeric a l i ssues (supercomputing)
Differential equations solved in MD
Basic concept: atomistic methods
PDE solv ed in MD:
2
m d r i
dU ( r )
j
r { r }
i 1 .. N
( ma F )
i dt 2
d r i
Results o f M D simulation:
r i ( t ), v i ( t ), a i ( t )
i 1 .. N 9
Complete MD updating scheme
(1) Initial conditions: Positions & velocities at t 0 (random velocities so that initial temperature is represented)
(2) Updating method (integration scheme - V erlet)
r i ( t 0 t ) r i ( t 0 t ) 2 r i ( t 0 ) t a i
( t 0
) t 2
...
Positions at t 0 - t
(3) Obtain accelerations from forces
Positions at t 0
Accelerations at t 0
f j , i
m j a j , i
a j , i
f j , i
/ m j
j 1 .. N
(4) Obtain force vectors from potential (s um over contributions from all neighbor of atom j )
4
d ( r )
x j , i
12
6
F
d r
f j , i F r
Potential
( r )
r
r
10
Algorithm of force calculation
6
…
5
j =1
i
4
2
3
r cut
for i=1..N
for j=1..N ( i ≠ j )
[add force contributions]
Loop
Summary: Atomistic simulation – numerical approach “molecular dynamics – M D”
Atomis tic model; requires atomistic mi crostructure and atomic positions at beginning (initial conditions), initia l velocities from random distribution according to specified temperature
Step through time by integration scheme (Verlet)
Repeat force calculation of atom ic forces based on their positions
Explic it notion of chemical bonds – c aptured in interatomic potential
Scaling behavior of MD code
Force calculation for N particles: pseudocode
Requires two nested loops, first over all atoms, and then over all other atoms to determine the distance
for i=1..N :
t total ~N·N t 0 =N 2 t 0
for j=1..N ( i ≠ j ):
t 1 ~N t 0
determine distance between i and j
calculate force and energy (if
r ij
< r cut , cutoff radius)
t 0
add to total force vector / energy
time ~ N 2 : computational disaster 14
Strategies for more efficient computation
Two appr oaches
1. Neighbor lis ts: Store information about atoms in vicinity, calculated in an N 2 effort, and keep information for 10..20 steps
Concept: Store information of neighbors of each atom within vicinity of cutoff radius (e.g. list in a vector); update list only every 10..20 steps
2. Domain decomposition into bins: Decompose system into small bins; force calc ulatio n only between atoms in local neighboring bins
Concept: Even overall system grows, calculation is done only in a loc a l environment (have two nest ed loops but # of atoms does not
increase locally) 15
Force calculation with neighbor lists
Requires two nested loops, first over all atoms, and then over all other atoms to determine the distance
i=1..N neighbors, i :
for j=1..N ( i ≠ j ):
determine distance between i and j
calculate force and energy (if
r < r
ij
cut
, cutoff radius)
t 0
add to total force vector / energy
for
t total ~N t 0
t 1 ~N t 0
time ~ N : computationally tractable even for large N 16
Periodic boundary conditions
Periodic boundary conditions allows studying bulk properties (no free surfaces) with small number of particles (here: N =3 ), all particles are “connected”
Original cell surrounded by 26 image cells; image particles move in exactly the same way as original particles (8 in 2D)
Particle leaving box enters on other side with same velocity vecto r .
Image by MIT OpenCou r s e Ware. After Buehl e r. 17
Parallel computing – “ supercomputers”
Imag es removed du e t o copyri g h t r e s t ri ctio ns . Pl e a se see h t t p : //www. san d ia. g ov / ASC / i ma ge s/ library / ASC I- Wh it e. jp g
Supercomputers consis t of a very large number o f individual computing units (e.g. Central Processing
Units, CPUs) 18
Domain decomposition
Each piece worked on by one of the computers in the supercomputer
Fig. 1 c from Buehl e r, M., et a l . "The D y nami cal Complexity of Wor k -Harden i ng: A Large - Scal e Mol e c u l a r Dynami c s Si mul a ti on.”
Acta Me c h S in i ca 2 1 (20 05) : 103-1 1 . © S p r ing e r- Ve rlag . A l l rig h ts rese rved . T h is c o ntent i s e x c l ud ed from our Cre a t i ve Commons lic ense .
For more i n fo rmati on, see h t t p :// oc w . m i t . e d u/ f a ir use . 19
Modeling and simulation
Modeling and simulation
What is a model? What is a simulation?
Modeling vs Simulation
• Mod e lin g : developing a mathem atical representation of a physi cal sit u ati o n
• Si mulation : solving the equations that arose from the development of the model.
© G oo gl e, Inc. Al l ri ghts r e se r v e d . This content is ex cl u d ed from ou r Creative Common s licen se. For more in fo r m a t io n , se e h t t p :// oc w . m i t . e d u/ f a ir use .
© M a s s achuse t t s B a y Tran s p o rtati o n Authori t y. All ri ghts re s e rv ed. Thi s c o nte n t i s ex cl u d ed from our Creative Common s lic ense . F o r mo re in fo r m a t io n , s ee h t t p :// oc w . m i t . e d u/ f a ir use .
Modeling and simulation
M S M S M
Atomistic versus continuum viewpoint
Diffusion: Phenomenological description
Physical problem
Ink dot
c d 2 c
t
D
dx 2
2 nd Fic k law (governing
equation)
© s o ur c e u n k n o w n. Al l rights res e rv ed. Thi s co ntent is ex cl u d ed from ou r Crea t i ve Common s licen se. For mo re in fo r m a t io n , s e e htt p :/ / o cw.mi t .edu /fai ru se
Tissue
BC: c ( r = ∞ ) = 0 24
IC: c ( r=0 , t = 0) = c 0
Continuum model: Empirical parameters
Continuum model requires paramet er that describes microscopic processes inside the material
Need experimental measurements to calibrate
Microscopic |
Co |
ntinuum model |
mechanisms ??? |
Time scale
“Empirical”
or experimental parameter feeding
Length scale 25
How to solve continuum problem: Finite difference scheme
c
t
d 2 c D dx 2
Concentration at i
at old time
i space
j time
c c
t D c
2 c c
“explicit” numerical scheme
i , j 1
i , j
x 2
i 1 , j
i , j
i 1 , j
(new concentration directly from
concentration at earlier time)
Concentration at i
at old time
Concentration at i
at new time
Concentration at i+ 1
at old time
Concentration at i- 1
at old time
26
Other methods : Finite element method
Atomistic model of diffusion
Diffusion at macroscale (change of concentrations) is result of microscopic processes, random motion of particle
Atomis tic model provides an alternative way to describe diffusion
Enables us to directly calculat e the diffusion constant from the trajectory of atoms
Follow trajectory of atoms and calc ulate how fast atoms leave their initial position
D p t
x 2
Concept:
follow this quantity over time
27
Atomistic model of diffusion
r
j
2
m d r i
dU ( r )
r
{ }
i 1 .. N
i dt 2 d r
i
Images cou rtesy of the Center for Polymer Studi e s at Bo sto n Uni v e r si ty. Use d wi th pe rmi s si o n .
r 2
Particles Trajectories
Mean Squared Displacement function
Average squares of dis p lacements of all particles
r 2 ( t )
1
0 ) 2
N
r i ( t )
i
r i ( t
28
Calculation of diffusion coefficient
r 2 ( t )
1 r ( t ) r ( t
0 ) 2
N
i i
i
Position of
atom i at time t
Position of
atom i at time t =0
(nm)
r 2
slope = D
Einstein equation
D 1 lim d r 2 ( t )
2 d t dt
(ps)
1D=1, 2D=2, 3D=3
29
Summary
Molec ular dynamic s provides a po werful approach to relate the diffusion constant that appears in continuum models to atomistic trajectories
Outlines multi-scale approach: Feed parameters from atomistic simulations to continuum models
Time scale
Co ntinuum model
MD
“Empirical”
or experimental parameter feeding
???
Len g th scale
30
1.1 Atomistic and molecular simulation algorithms
1.2 Property calculation
1.3 Potential/force field models
1.4 Applications
Goals: How to calc ulate “useful” properties from MD runs (temperature, pressure, RDF, VAF,..); significance of averaging; Monte Carlo schemes
Property calculation: Introduction
Have:
r i ( t ), v i ( t ), a i ( t )
i 1 .. N
“microscopic information” Want:
Thermodynamical properties (temperature, pressure, ..)
Transport properties (diffusivities, shear viscosity, ..)
Material’s state (gas, liquid, solid)
Micro-macro relation
T ( t )
Which to pick?
1 1 N t
T ( t )
m v 2 ( t )
33
Specific (individual) microscopic states are insufficient to relate to macroscopic properties
Images cou rtesy of the Center for Polymer Studies at Bosto n Uni v e r si ty. Use d wi th permi s si o n.
3 Nk B
i i
i 1
Ergodic hypothesis: significance of averaging
A
A ( p , r ) ( p , r ) drdp
p r
property must be properly averaged
Ergodic hypothesis:
Ensemble (statistical) average = time average
t i 1 .. N t
MD
Average over time steps
DYNAMICAL INFORMATION
1
All microstates are sampled with appropriate probability dens ity o ver long time scales
N A i 1 .. N
A
1
A ( i )
A Ens
A Time N
A ( i )
Monte Carlo
34
Average over Monte Carlo steps
NO DYNAMICAL INFORMATION
Monte Carlo scheme
Concept: Find convenient way to solve the integral
A
A ( p , r ) ( p , r ) drdp
p r
Use idea of “random walk” t o step through relevant microscopic states and thereby create proper weighting (visit states with higher probability density more often)
Monte Carlo schemes : Many applications (beyond what is discussed here; general method to solve complex integrations)
Monte Carlo scheme: area calculation
Method to carry out integration (illustrate general concept)
Want:
A
f ( x ) d
E.g. : Area of circle (value of )
d 2
A C 4
A C 4
d 1
Monte Carlo scheme
in
x i
Step 1: Pick random point
Step 2: Accept/reject point based on criterion (e.g. if inside or outside of circle and if in area not yet counted)
Step 3: If accepted, add
f ( x i ) 1
to the total sum otherwise
f ( x i ) 0
d 1 / 2
A C
f ( x ) d
A 1 f ( )
C
N
x i
A
i
N A : Attempts
made
Courtes y of Jo hn H. Mathew s. Us ed wi t h pe rmi s si o n . 37
See also: http://math.fullerton.edu/mathews/n2003/MonteCarloPiMod.html
Area of Middlesex County (MSC)
A
SQ
10 , 000 km 2
x
y
10 0 k m
100 km
Image courtesy of Wikimedia Commons.
Fraction of points that lie within MS County
A MSC
1
A SQ N
f ( x i )
Expression provides area of MS County
A i 38
Detailed view - schematic
N A =55 points (attempts) 12
f ( )
x i
12 points within
A MSC
1
N
A SQ
A
i
10000 0 . 22 km 2
2181 . 8 km 2
39
Results U.S. Census Bureau
= 2137 km 2
823.46 square miles (1 square mile=2.58998811 km 2 )
Taken from: http://quickfacts.census.g ov/qfd/states/25/25017.html
A
MSC
2181 . 8 km 2
Monte Carlo result:
40
Analysis of satellite images
Image remo v e d du e to co py ri ght restri cti o n s .
G oog le Sa t e ll it e ima g e o f Sp y P o n d , in Ca mb r i d ge , M A .
200 m 41
Metropolis Hastings algorithm
Images r e mo ve d d u e to c o py ri ght restri cti o n s .
Pl ease s e e: Fi g. 2. 7 i n Bue h l e r, Mark u s J. At o m i s t i c Mo de li n g of Mater i al s Fail ur e . S p ri n g er , 20 0 8.
Images r e mo ve d d u e to c o py ri ght restri cti o n s .
Pl ease s e e: Fi g. 2. 8 i n Bue h l e r, Mark u s J. At o m i s t i c M o d e l i n g of Material s Fail ur e . Sp ringe r , 2 008 .
A
A ( p , r ) ( p , r ) drdp
p r 42
Molecular Dynamics vs. Monte Carlo
MD provides actual dynamical data for nonequilibrium processes (fracture, deformation, instabilities)
Can study onset of failure, instabilities
MC provides information about equilibrium properties
(diffusivities, temperature, pressure) Not suitable for processes like fracture
1
N A i 1 .. N
A ( i )
A
A Ens
A Time
1
N t i 1 .. N
A ( i )
43
t
Property calculation: Temperature and pressure
Temperature
1 1 N 2
v
2
T
3 Nk B
m i v i
i 1
i v i
v i
T ~ v 2
v ~
T
44
Temperature control in MD ( NVT ensemble) Berendsen thermostat
r ( t t ) 2 r ( t ) r ( t t ) a ( t
) t 2
...
i 0 i 0 i 0 i 0
1
1 N 2
Calculate temperature
T
3 Nk B
m i v i
i 1
T
v ~
Calculate ratio of current vs. desired temperature
45
Rescale velocities
Interpretation of RDF
46
Formal approach: Radial distribution function (RDF)
Density of atoms (volume)
g ( r ) ( r ) /
Local dens ity
The radial distribution function is defined as
Provides information about the density of atoms at a given radius r ; ( r ) is the local density of atoms
N um b er of atoms in the interv al r r
2
g ( r )
2
N ( r ) 1
r
2
Volume o f this shell ( dr )
( r r )
g ( r ) 2 r 2 dr
Number of particles that lie in a spherical shell 47
of radius r and thickness dr
g ( r )
g ( r )
Radial distribution function: Solid versus liquid versus gas
5
5
4
S o l i d A r g o n
4
Gaseous Ar (90 K)
3
3
Liquid Ar (90 K)
2
2
Gaseous Ar (300 K)
L i q u i d A r g o n
1
1
0 0
0 . 2
0 . 4
d i s t a n c e / n m
0 . 6
0 . 8
0 0
0 . 2
0 . 4
d i s t a n c e / n m
0 . 6
0 . 8
Image by MIT OpenCou r seWare.
Note: The first peak corresponds to the nearest neighbor shell, the second peak to the second nearest neighbor shell, etc.
In FCC: 12, 6, 24, and 12 in first four shells 48
RDF and crystal structure
3 r d NN
L i q u i d A r g o n
S o l i d A r g o n
…
2 nd NN
1 st nearest neighbor (NN)
5
4
g ( r )
3
2
1
0 0 0 . 2 0 . 4 0 . 6 0 . 8
d i s t a n c e / n m
Image by MIT OpenCou r seWare.
Peaks in RDF characterize NN distance, can infer from RDF about crystal structure
49
http://physchem.ox.ac.uk/~rkt/lectures/liqsolns/liquids.html
50
Imag es c o u r t e sy of Ma r k Tucker man. Used wi th permi ssion.
Interpretation of RDF
1 st nearest neighbor (NN) 2 nd NN
3 rd NN
copper: NN distance > 2 Å
X
not a liquid (sharp peaks) 51
Graphene/carbon nanotubes
RDF
Images of gr aph e ne/ c ar bo n nan utu bes :
http: / / webl o g s 3 .nr c . nl / tec h n o /w p- conte n t/ up loads / 0804 24_G rafe en/ G raphene _xyz.jpg
http: / /d e pts. was h i n gto n . e d u / p ol yl ab /i mage s / c n 1. j p g
Graphene/carbon nanotubes (rolled up graphene)
NN: 1.42 Å, second NN 2.46 Å … 52
Summary – property calculation
Property |
Definition |
Application |
Temperature |
N T 1 1 m 2 2 3 Nk i v i v i v i v i B i 1 |
Direct |
MSD |
r 2 ( t ) 1 r ( t ) r ( t 0 ) 2 N i i i |
Diffusivity |
RDF |
g ( r ) N ( r r ) 2 ( r r ) 2 |
Atomic structure (signature) |
Material properties: Classification
Structural – c rystal structure, RDF
Thermodynamic -- equation of stat e, heat capac ities, thermal expansion, free energies, use RDF, temperature, pressure/stress
Mechanic al -- elastic constants, cohes ive and shear strength, elastic and plastic deformation, fracture toughness, use stress
Trans port -- diffusion, viscous flow, thermal conduction, use MS D, temperature
Bell model analysis (protein rupture)
Bell model analysis (protein rupture)
a =86.8 6 p N
f ( v ; x b , E b ) a ln v b
b= 800 pN
a k B T
x b
(1)
k B =1.3806505E-23 J/K
Get a and b from fitting to the graphs
k T
E
0 b
b b l n x
x b
ex p b
k b T
(1)
So lve (1) for a , use (2) to solve for E b
0
1 1 0 13 1 / sec
a= (800-400)/(0-(-4.6))) pN
=86.86 pN x b =0.47 Å 56
Determining the energy barrier
b
k b T
ln 0 x b
E
exp b
k b T
ln x
E b
bx b
x b
ln x E b
k b T
0 b
x b
k b T
0 b
b
k b T k T
E b
ln x
bx b
0 b
b
k b T k T
E ln x bx b k T
b 0 b
b
k b T
b= 800 pN E b ≈ 9 k cal/mol
1 kcal/mol=6.9477E-21 J
57
Poss ible mechanis m: Rupture of 3 H-bonds (H-bond energy 3 kcal/mol)
Scaling with E b : shifts curve
f ( v ; x b , E b ) a ln v b
E b
k B T
k B T
E b
a b
x b x b
ln v 0
v 0 0
x b
exp
58
k b T
Scaling with x b : changes slope
f ( v ; x b , E b ) a ln v b
x b
k B T
k B T
E b
a b
x x
ln v 0
v 0 0
x b
exp
k
T
b b 59 b
1.1 Atomistic and molecular simulation algorithms
1.2 Property calculation
1.3 Potential/force field models
1.4 Applications
Goals: How to model chemical interactions between particles (interatomic potential, force fields); applic ations to metals, proteins
60
Concept: Repulsion and attraction
Ener gy U
r
1/r 12 (or Exponential)
Repulsion
Radius r (Distance between atoms)
e
Attraction
1/r 6
Electrons
Core
r
“point particle” representation
Image by MIT OpenCou r seWare.
Generic shape of interatomic potential
Ener gy U
r
1/r 12 (or Exponential)
Repulsion
Radius r (Distance between atoms)
e
Attraction
1/r 6
Effective
interatomic potential
r 0
Harmonic oscillator
~ k(r - r 0 ) 2
r
Image by MIT OpenCou r seWare.
Image by MIT OpenCou r seWare.
Many chemical bonds show this generic behav ior
Atomic interactions – different types of chemical bonds
Prima ry bonds (“strong”)
Ionic (ceramics, quartz, felds par - rocks )
Weak er bonding
Covalent ( silicon )
Metallic (copper, nickel, gold , silver) (high melting point, 1000-5,000K)
Secondary bonds (“weak”)
Van der Waals ( wax , low melting point)
Hy drogen bonds (proteins, spider silk ) (melting point 100-500K)
Ionic: Non-directional (point charges interacting)
Covalent: Directional (bon d angles, torsions matter)
Metallic: Non-directional (electron gas concept)
Know models for a ll types of chemical bonds! 63
How to choose a potential
64
How to calculate forces from the “potential” or “force field”
Define interatomic potentials, that describe the energy of a set o f atoms as a function of their coordinates
“Potential” = “force field”
r r j
j 1 .. N
U total
U total
( r )
Depends on pos ition of all other atoms
Position vector of
F i
U
r
i
total
( r )
i 1 .. N
65
atom i
r i
r 1 , i
,
r 2 , i
,
r 3 , i
Change of potential energy due to change of position of particle i (“gradient”)
Force calculation
Pair potential
Note cutoff!
66
Pair potentials: energy calculation
Simple approximation: Total energy is sum over the energy of all pairs of atoms in the system
Pair wise interaction potential
( r ij )
r 12
r 25
Pair wise summation of bond energies avoid double counting
N N
2
U tot 1
( r ij )
i 1 , i j j 1
r ij
distance between particles i and j
En erg y of atom i
U i
( r ij )
N
j 1 67
Total energy of pair potential
Assumption: Total energy of system is ex pressed as sum of the energy due to pairs of atoms
r
r
23
12
N N
2
U total 1
( r ij )
i 1 , i j j 1
with
ij
( r ij )
U 1
= 0
total 2 12
=0
21 23
31 32
13
beyond cutoff 68
Force calculation – pair potential
Forces can be calculated by taking der ivatives from the potential function
Force magnitude: Negative derivative of potential energy with respect to atomic distance
F
d ( r ij ) d r ij
To obtain force vector F i , take projections into the three axial directions
Compo n ent i of j
f F x i
vector
r ij
r ij
r
i
x 1
ij i f
x 2 x
r
f 2 2
69
ij r ij
f 1 x 1
Force calculation – pair potential
Forces on atom 3: only interaction with atom 2 (cutoff)
1. Determine distance between atoms 3 and 2, r 23
2. Obtain magnitude of force vector based on derivative of potential
3. To obtain force vector F i , take projections into the three axial directions
Component i of
d ( r 23 )
vector
x i
r ij
r
F
d r 23
f i F
r 23
23 r 23
70
ij
ij
Interatomic pair potentials: examples
( r ij )
D exp 2 ( r
r 0
) 2 D exp ( r
r 0 )
Morse potential
( r ij )
4
r ij
12 6
r
ij
Lennard-Jones 12:6 potential (excellent model for noble gases, Ar, Ne, Xe..)
r
6
( r ) A exp i j C
ij
r
Buck ingham potential
ij
71
Harmonic approximation
Lennard-Jones potential – example for copper
0.2
0.1
(eV)
0
-0.1
-0.2
2
6 2 = r 0
o
r 0 3 4 5
r (A)
Image b y MIT OpenCo u rseW are.
LJ potential – p arameters for copper ( e.g.: Cleri et al ., 1997 ) 72
-d /dr (eV/A)
Derivative of LJ potential ~ force
0.2
0.1
F = _ d ( r ) = - '
d r
0
-0.1
( r )
F max, LJ
-0.2
2
r 0
3
4
5
r (A)
o
Image by MIT OpenCou r seWare.
EQ r 0
73
Cutoff radius
U i
( r ij )
N
j 1
6
…
5
j=1
i
4
2
3
r cut
U i
r cut
LJ 12:6
potential
~
( r ij )
j 1 .. N neigh
r
Cutoff radius = considering interact ions only to a certain distance Basis: Force contribution negligible (slope) 74
-d /dr (eV/A)
r cut
Derivative of LJ potential ~ force
0.2
0.1
F =
_ d ( r ) d r
force not z ero
0
P otential shift
-0.1
-0.2
2
r 0
3
4
5
r (A)
o
Image by MIT OpenCou r seWare.
75
Beyond cutoff: Changes in energy (and thus forces) small
Crystal structure and potential
The regular packing (ordering) of atoms in to crystals is closely related to the potential details
N=4 bonds
N=6 bonds per atom
Square lattice
Hexagonal lattice
Many local minima for crystal structures exist, but materials tend to go to the structure that minimizes the ener gy; often this can be understood in terms of the energy per atomic bond an d the equilibrium distance ( at which a bond features the most potential energy)
LJ 12:6
potential
~
2D example
76
r
Example
Initial: cubic lattice Transforms into triangular lattice
Images co u rte sy of the Center for P o lymer S t u die s a t Bosto n Uni v e r si ty. Us ed w i t h p e r m iss i on .
time
All bonds are not the same – metals
Surface
Bulk
stronger
+ different bond EQ distance
Pair potentials: All bonds are equal!
Reality: Have environment effects; it matter that there is a free sur f ace!
78
Embedded-atom method (EAM): multi-body potential
i
1 ( r
new
) F ( )
2
ij i
j 1 .. N neigh
Pair potenti a l energy
Embeddi ng
energy as a function of electron density
i
i
Electron density at atom i
based on a pair potential:
( r ij )
j 1 .. N
neigh
Models other than EAM (alternatives):
79
Glue model (Ercolessi, Tosatti, Parrinello) Finnis Sinclair
Equivalent crystal models (Smith and Banerjee)
Effective pair interactions: EAM potential
1
0.5
Bulk
Surface
0
-0.5
2
3
4
r (A)
o
Ef fective pair potential (eV )
EAM=Embedded atom method
Can describe differences between bulk and surface
Image by MIT OpenCou r seWare .
Pair potential energy
Embedding ener gy
as a function of electron density
U 1 ( r ) F ( )
2 ij i
Embedding term: depends on environment, “multi-body” 80
i , i j j i
Effective pair interactions: EAM
r
+ + + + + +
+ + + + + +
+ + + + + +
r
+ + + + + +
+ + + + +
+ + + + +
+
+
1
0.5
Bulk
Surface
Change in
NN dis t ance
0
-0.5
2
3
4
r (A)
o
Ef fective pair potential (eV )
Image by MIT OpenCou r seWare.
Can describe differences between bulk and surface
81
Da w, Foile s, Baskes, Mat. Science Reports , 1993
Model for chemical interactions
Similarly: Potentials for chemically comple x materials – a ssume that total energy is the sum of the energy of different types of chemical bonds
U total
U Elec
U Covalent
U Metallic
U vdW
U H bond
Concept: energy landscape for chemically complex materials
U total
U Elec
U Covalent
U Metallic
U vdW
U H bond
Different energy contributions from different kinds of chemical bonds are summed up individually, independently
Implies that bond properties of co valent bonds are not affected by other bonds, e.g. vdW interactions, H-bonds
Force fields for organic substances are constructed based on this concept:
water, polymers, biopolymers, proteins …
Summary: CHARMM-type potential
=0 for proteins
U total
U Elec
U Covalent
U Metallic
U vdW
U H bond
U : Coulomb potential
( r )
q i q j
Elec
ij r
1 ij
stretch
1 k
2
2
2
stretch
( r r 0 )
U Covalent
U stretch
U bend
U rot
bend
1 k
2
bend (
0 )
rot
1 k
2
rot
( 1 cos ( ))
12 6
r ij
U vdW :
LJ potential
( r ij )
4
r
ij
R
12 R
10
U H bond :
( r
) D
5 H bon d
6 H bon d
cos 4 ( )
ij H
bond
r ij
r ij
DHA 84
Summary of e nergy expressions: CHARMM, DREIDING, etc.
B ond stretching
Electrostatic inter actions
Angle Bending
vdW Inter actions
B ond R otation
vdW ONLY
between atoms of different molecules
Image by MIT OpenCou r seWare.
….
85
2
Identify a strategy to model the ch ange of an interatomic bond under a chemical reaction (based on harmoni c potential) – f rom single to double bond
Energy
Effective
interatomic potential
r 0
Harmonic oscillator
~ k(r - r 0 ) 2
r
stretch
1 k
2
stretch ( r
r 0 )
Image by MIT OpenCou r seWare.
focus on C-C bond
r
Energy
stretch
Trans ition point
sp 3
BO=1
sp 2
BO=2
sp 2
C-C distance
s p 3
r
Solution sketch/concept
1 k ( r r ) 2
k stretch k stretch (BO)
stretch 2 stretch 0
r 0 r 0 (BO)
Make potential parameters k stretch and r 0 a function of the chemical state of the molec u le (“modulate parameters”)
E.g. use bond order as parameter, which allows to smoothly interpolate between one type of bonding and anot her one dependent on geometry of molec u le See lecture notes (lecture 7): Bond order
T riple
D ouble Single
S .C.
F .C.C.
5
0
-5
-10
0.5
1
1.5 2
2.5
3
3.5
o
D istance (A)
Effect ive pair-int eractio ns for vario us C-C (Carbo n) bonds
P otential energy (eV)
potential for silicon
Fi g. 2. 21 c i n Buehl e r, Mar k u s J. A t o m i st i c Mod e lin g of Material s Fail ur e . Sp ringe r , 2 008 .
© S pri n ge r. A ll ri ghts re s e r v e d . Thi s c o ntent is ex cl u d ed from ou r Creative Co mmo ns lice n se . F o r mo r e in fo r m a t io n , s e e http:/ /o c w .mi t .edu /fai ru se .
Image by MIT OpenCou r seWare.
Summary: CHARMM force field
Widely used and accepted m odel for protein structures
Programs such as NAMD have implemented the CH ARMM force field
E.g. , problem set 3 , nanoH UB stretchmol/NAMD module, study of a protein domain part of human vimentin intermediate filaments
Overview: force fields discussed in IM/S
Pair potentials (LJ, Morse, harmonic potentials, biharmonic potentials), used for single crystal elasticity (pset #1) and fracture model (pset #2)
Pair potential
EAM (=Embedded Atom Method), used for nanowire (pset #1), suitable for metals
Multi-body potential
ReaxF F (reactive force field), used for CMDF/fracture model of silicon (pset #2) – very good to model breaking of bonds (chemistry)
Multi-body potential (bond order potential)
Tersoff (nonreactive force field), used for CMDF/fracture model of silicon (note: Tersoff only suitable for elasticity of silicon, pset #2)
Multi-body potential (bond order potential)
CHARMM force field (organic force field), used for protein simulations (pset #3)
Multi-body potential (angles, for instance)
How to choose a potential
ReaxFF
EAM, LJ
CHA R MM-type (organic)
ReaxFF
CHARMM
SMD mimics AFM single molecule experiments
Atomic force microscope
v
pset #3
k
x
v
k
x
f
x
Steered molecular dynamics (SMD)
Steered molecular dynamics used to apply forces to protein structures
pset #3
v
Virtual atom f
moves w/ velocity v k
x
f k ( v t x )
v t
end point of
x
SMD spring constant
molec u le
f k ( v t x )
SMD
deformation speed vector
time
Distance between end point of molecule and virtual atom
92
Comparison – CHARMM vs. ReaxFF
Covalent bonds never break
in CHARMM
93
M. Buehler, JoMMS , 2007
1.1 Atomistic and molecular simulation algorithms
1.2 Property calculation
1.3 Potential/force field models
1.4 Applications
Goals: Select applications of MD to address questions in materials science (ductile versus brittle materials beh avior); observe what can be done with
MD 94
Application – mechanics of materials tensile test of a wire
Image by MIT OpenCou r seWare.
Necking
Brittle
Ductile
Brittle
Ductile
Strain
Stress
I mage by MIT OpenCou r seWare.
Brittle versus ductile materials behavior
Ductile versus brittle materials
BRITTLE
DUCTILE
Glass Polymers Ice...
Copper , Gold
Shear load
Difficult
to deform, breaks easily
Image by MIT OpenCou r seWare.
Easy to deform hard to break
Deformation of materials:
Nothing is perfect, and flaws or cracks matter
“Macro, global”
( r )
“M icro (nano), local”
r
Failure of materials initiates at cracks
Griffith, Irwine and others: Failure initiates at defects, such as cracks, or
grain boundaries with reduced tracti on, nano-voids, other imperfections 98
Crack extension: brittle response
( r )
r
Large stresses lead to rupture of chemical bonds between atoms
Thus, crack extends
99
Image by MIT OpenCou r seWare.
Basic fracture process: dissipation of elastic energy
a
Undeformed Stretching=store elastic energy Release elastic energy
dissipated into breaking chemical bonds
100
Limiting speeds of cracks: linear elastic
continuum theory
Mother-daughter mechanism
Super- Sub-Rayleigh Rayleigh
Mode II
Intersonic
Supersonic
Mode I
C r C s
C l
Limiting speed v
Subsonic
Supersonic
Mode III
C s
C l
Limiting speed v
Linear Nonlinear
Image by MIT OpenCou r seWare.
• C racks can not exceed the limiting speed given by the corresponding wave speeds unless materia l behavior is nonlinear
101
• C racks that exceed limiting s peed would produce energy (physically impos sible - linear elastic continuum theory )
Summary: mixed Hamiltonian approach
W i
100%
W 2
W 1
0%
R - R buf
R
R+R tr ans R+R tr ans
+R buf
x
R eaxFF
T r ansition la y er
T ersoff
T r ansition region
T ersof f ghost atoms
R ea xFF ghost a toms
Image by MIT OpenCou r seWare.
F ReaxFF Tersoff
w ReaxFF ( x ) F ReaxFF
( 1
w ReaxFF ) F Tersoff
w ReaxFF ( x )
w Tersoff
( x ) 1 x
102
Atomistic fracture mechanism
103
Image by MIT OpenCou r seWare.
Lattice shearing: ductile response
Instead of crack extension, induce shearing of atomic lattice
Due to large shear stresses at crack t ip
Lecture 9
Image by MIT OpenCou r seWare.
Image by MIT OpenCou r seWare.
104
Concept of dislocations
additional half plane
b
Image by MIT OpenCou r seWare.
Localization of shear rather than homogeneous shear that requires
cooperative motion
“size of single dislocation” = b , Burgers vector
105
Final sessile structure – “ brittle”
Fig. 1 c from Buehl e r, M., et a l . "The D y nami cal Comple xi ty of Wor k -Harden i ng: A Large - Scal e Mol e c u l ar Dynami c s Simula tion." Acta Me c h S in i ca 2 1 (20 05) : 103-1 1 .
© S pri n ge r -V e rl ag. Al l ri ghts r e se r v e d . Thi s co nte n t i s excl u d ed f r om our Creative Common s lic ense . F o r mo r e in fo r m a t io n , s ee h t t p ://ocw.m i t .e d u / f a i r u se .
106
Brittle versus ductile materials behavior
Copper, nickel (ductile) and glas s, silicon (brittle)
For a material to be ductile, require dis l ocations, that is, shearing of lattices
Not possible here (disordered)
© s ou rce unk no wn . All r i gh t s r e ser v ed . T h is c o n t en t is e x c lud ed from our Creative Common s licen se . F o r m o re in fo rm a t io n , s ee h t t p :// oc w . m i t . e d u/ f a ir use.
107
Crack speed analysis
crack has stopped
slope=equal to crack speed
MD simulation: chemistry as bridge between disciplines
MD
Application – protein folding
ACGT
Four letter code “DNA”
Transcription/ translation
.. - P roline - S erine – Proline - Alanine - . .
Sequence of amino acids “polypeptide” (1D structure)
Combination of 3 DNA letters equals a amino acid
E.g. : Proline –
CCT, CCC, CCA, CCG
Folding (3D structure)
Goal of protein folding simulations:
Predic t folded 3D structure based on poly peptide sequence
Movie: protein folding with CHARMM
de novo Folding of a Transmembrane fd Coat Protein
http://ww w.charmm- gui.org/?doc=gallery&id=23
Polypeptide chain
Quality of predicted structures quite good
Confirmed by comparison of the MSD deviations of a room temperature ensemble of conformations from th e replic a-exchange simulations and experimental structures from both solid-state NMR in lipid bilayers and
solution-phas e NMR on the protein in micelles)
111
2. Important terminology and concepts
Important terminology and concepts
Force field
Potential / interatomic potential
Reactive force field / nonreactive force field
Chemical bonding (covalent, me tallic, ionic, H-bonds, vdW..)
Time step
Continuum vs. atomistic viewpoints
Monte Carlo vs. Molec u lar Dynamics
Property calculation (temperature, pressure, diffusivity [transport properties]-MSD, structural analy s is-RD F )
Choice of potential for different materials (pair potentials, chemical complexity)
MD algorithm: how to calc ulate forces, energies
MC algorithm (Metropolis-Hastings)
Applications: brittle vs. ductile , crack speeds, data analysis
3. Continuum vs. atomistic approaches
Relevant scales in materials
(atom) << (crystal) << d (grain) << dx , dy , dz << H , W , D
Image from Wi ki medi a Common s , h t t p ://c o m mons
Courtesy of Elsevier, Inc.,
Fi g. 8. 7 i n : Bue h l e r, M.
y
yy
n y
yz
z Image by MIT
yx
xz
A y
xy
n x
A x
xx
x
http://www.scien c edirect. com . Us ed w i t h p e r m iss i on .
A t o m is t ic Mod e lin g o f M a t e ri a ls Failu re . Sp ring er, 2 008 . © Sp ring er. All rig h ts reserv e d . Thi s co nte n t is ex cl u d e d from
our Creative Common s licen se.
Op en Cou r seW a r e .
Bottom-up
Atomis tic viewpoint :
For more i n fo rmati on, see h t t p :// oc w . m i t . e d u/ f a ir use .
Top-down
•Explic i tly consider discrete atomistic structure
•Solve for atomic trajectories and infe r from these about material properties & behavior
•Features internal length scales (atomic distance)
“Many-particle system with statistical properties” 116
Relevant scales in materials
Separation of scales
RVE
(atom) << (crystal)
<< d (grain)
<< dx , dy , dz << H , W , D
y A y
yy
Image from Wi ki medi a Common s , h t t p ://c o m mons
Courtesy of Elsevier, Inc., http://www.scien c edirect. com .
Fi g. 8. 7 i n : Bue h l e r, M.
A t o m is t ic Mod e lin g o f M a t e ri a ls z
n y
yz
Image by MIT
yx
xz
xy
n x
A x
xx
x
Us ed w i t h p e r m iss i on .
Continuum viewpoint :
Failu re. Sp ring er, 2 008 . © Sp ring er. All rig h ts reserv e d . Thi s co nte n t is ex cl u d e d from our Creative Common s licen se. For more i n fo rmati on, see h t t p :// oc w . m i t . e d u/ f a ir use .
Op en Cou r seW a r e .
Top-down
•Treat material as matter with no internal structure
•Develop mathematical model (governi ng equation) based on representative volume element (RVE, contains “enough” ma terial such that internal structure can be neglected
•Features no characteristic length scales, provided RVE is large enough 117
“PDE with parameters”
Example – diffusion
c
t
Example solution – 2 nd Fick’s law
d 2 c
D
dx 2
Concentra t ion
c 0
c 0 x
time t
c ( x , t )
BC: c ( x = 0) = c 0 x
IC: c ( x > 0, t = 0) = 0
Need diffusion coefficient to solve for distribution!
2. Finite difference method
How to solve a PDE
c
t
d 2 c D dx 2
+ B C s , I C s
Note: Flux
J D dc
dx
120
c
t
d 2 c D dx 2
Finite difference method
discrete grid
t
j
t
x
i
Idea: Instead of solving for continuous field
c ( t , x )
(space and time)
solve for
c ( t i , x j )
i space
j time
c ( t i , x j )
c i , j
i 1 .. N x
121
c
t
d 2 c D dx 2
Finite difference method
Idea: Instead of solving for continuous field
c ( t , x )
solve for
c ( t i , x j )
Approach: Express continuous deriv atives as discrete differentials
c c
t t
c
t
d 2 c D dx 2
Finite difference method
Idea: Instead of solving for continuous field
c ( t , x )
solve for
c ( t i , x j )
c c
t
t
c c
c
2
c
t
x
x
x 2
x
Approach: Express continuous deriv atives as discrete differentials
Forward, backward and central difference
c
c
x
x , t
i j
forward
c
backward
x
Forward difference
Back ward difference
Central difference
c i 1 , j c i , j c i 1 , j
cent ral
x
c
c i 1 , j c i , j c i 1 , j
x i 1
x i x x i 1
x i 1 x i
x i 1
How to calculate derivatives with discrete
c
t
t j
t j 1
t
differentials c
c c
t t
c
t
d 2 c D dx 2
c i , j 1
c i , j
c
t
c i , j 1 c i , j c i , j 1 c i , j
(1)
x , t
i j
t j 1 t j
t
t discrete time step
c
t
x i , t j
How to calculate derivatives with discrete differentials
c
c
t
d 2 c
D dx 2
c
c x x , t
c
x x , t
c c
2 c
t
i 1 j
i 1 j
x x
x 2
x
2 2
c i 1 , j
c i , j
c i 1 , j
c
c i 1 , j
c i , j
c i 1 , j
c i , j
cent ral
x x
1 , t j
x i 1 x i x
x i 1 x i
x
x i 1
2
i 2
c c
c c
x i 1
x i 1
c
x
2
i , j i 1 , j i , j i 1 , j
x 1
i 2
, t j
x i x i 1 x
c
x
x , t
i j
2 c
x 2
x i , t j
1 , j
2
1 , j
2
cent ral
x
How to calculate derivatives with discrete differentials
c c
x x
2 c
x 2
c
x
x
c
t
d 2 c D dx 2
c ' i
c ' i
c
x
c c c c
i 1 , j i , j i 1 , j i , j
x x x
x 1 x x 1
x 1
i 2
, t j
i 1 i
i 2 i
i 2
c
c i , j
c i 1 , j
c i , j
c i 1 , j
Apply central difference
x x
1 , t j
x i
x i 1 x
method again…
2 c
x 2
c
x x
c
1 j
, t
x
x , t
i
1
j
c
c c
(2)
c
c
2 c c
i 2
2
2
i 2
2
i 1 , j i , j i , j i 1 , j
i 1 , j i , j i 1 , j
x i , t j
x i 1
x i 1
x 2
x 2 127
Complete finite difference scheme
c d 2 c
c 2 c c
t D dx 2
2 c
x 2
x i , t j
i 1 , j i , j i 1 , j
x 2
c
t
c i , j 1 c i , j
c i , j 1
c i , j
D c i 1 , j
2 c i , j
c i 1 , j
x i , t j t
t
x 2
Complete finite difference scheme
c d 2 c
c 2 c c
t D dx 2
2 c
x 2
x i , t j
i 1 , j i , j i 1 , j
x 2
c
t
c i , j 1 c i , j
c i , j 1 c i , j
t
Want
D c i 1 , j
c
i , j 1
c t D c
i , j
x 2
i 1 , j
2 c c
i , j
i 1 , j
2 c i , j
x 2
c i 1 , j
x i , t j t
Complete finite difference scheme
c
t
d 2 c D dx 2
Concentration at i
at old time
i space
j time
c c
t D c
2 c c
“explicit” numerical scheme
i , j 1
i , j
x 2
i 1 , j
i , j
i 1 , j
(new concentration directly from
concentration at earlier time)
Concentration at i
at old time
Concentration at i
at new time
Concentration at i+ 1
at old time
Concentration at i- 1
at old time
Summary
Developed finite difference approach to solve for diffusion equation
Use parameter ( D ), e.g. calculated from molecular dynamics, and solve “complex” p roblem at continuum scale
Do not consider “atoms” o r “particles”
Multi-scale approac h:
Summary
Feed parameters from atomistic s i m u lations to continuum models
Time scale
Co ntinuum model
MD
“Empirical”
or experimental parameter feeding
Quantum
mechanics
Length scale