Finite-temperature equation of state. T ln 2sinh h" '-

Size: px
Start display at page:

Download "Finite-temperature equation of state. T ln 2sinh h" '-"

Transcription

1 Finite-temperature equation of state * $ F(V,T) = U 0 + k B T ln 2sinh h" '- #, & )/ + % 2k B T (. 0 # Compute vibrational modes, frequencies Evaluate at a given volume V Compute F at various temperatures T with above Need the Hessian!

2 Start again with fcc lattice Atoms should be relaxed (zero force on atoms) Evaluate at a given volume V Compute F at various temperatures T and volumes V

3 Generate non-primitive basis-- 4 atoms! start with non-primitive fcc basis r1(1)=0.0d0 r2(1)=0.0d0 r3(1)=0.0d0 r1(2)=0.5d0 r2(2)=0.5d0 r3(2)=0.0d0 r1(3)=0.5d0 r2(3)=0.0d0 r3(3)=0.5d0 r1(4)=0.0d0 r2(4)=0.5d0 r3(4)=0.5d0

4 Some parameters for lattice INTEGER, PARAMETER :: nn=4 INTEGER, PARAMETER :: Prec14=SELECTED_REAL_KIND(14) INTEGER, PARAMETER :: natoms=4*nn**3 INTEGER, PARAMETER :: nx=nn,ny=nn,nz=nn REAL(KIND=Prec14), PARAMETER :: sigma=1.0d0,epsilon=1.0d0 4x4x4 lattice of non-primitive units 64x4=256 atoms System has 256x3=768 degrees of freedom! The Hessian matrix needs to be 768x768

5 Generate the full lattice n=0 do ix=1,nx do iy=1,ny do iz=1,nz do i=1,4 n=n+1 rx(n)=(r1(i)+dble(ix-1))*sigma ry(n)=(r2(i)+dble(iy-1))*sigma rz(n)=(r3(i)+dble(iz-1))*sigma enddo enddo enddo enddo! scale lengths by box size rx=rx/nx ry=ry/ny rz=rz/nz

6 We need more than forces this time! Definition of Hessian matrix elements H iµ, j" = # 2 U #r iµ #r j" For N atoms, this means a 3Nx3N matrix Many elements will be zero due to cutoff First derivative is just related to force on j: "U "r j# = % k ( ) "U r $ r j# k# "r kj r kj But need higher order derivatives!

7 " 2 U = $ " 2 U 2 "r iµ "r j# "r ij We need more than forces this time! H iµ, j" = # 2 U #r iµ #r j" For i,j referring to different atoms Also need terms where i=j ( r iµ $ r )( jµ r i# $ r ) j# + "U &( r $ r )( iµ jµ r i# $ r ) j# $ % ) µ,# ( r ij "r ij '( r ij r ij * + " 2 U "r iµ "r i# = - k,i " 2 U "r ik 2 ( ) ( r iµ $ r ) kµ r i# $ r k# $ 2 r ik - k,i "U &( r $ r ) iµ kµ ( r i# $ r k# ) $ % ) µ,# ( + 3 "r ik '( r ik r ik * + Notice that for each pair of components µ,ν, we have # H j iµ, j" = 0 or H iµ,i" = #% H iµ, j" j$i Can be easily tested in code! Also Hessian is symmetric

8 How does this relate to the phonon frequencies? Assume harmonic motion, so that the displacements are u iµ (t) = 1 # a 1/ 2 " $ iµ," e i% " t m i " And the potential energy is quadratic in displacements U = U " 2 U $ u iµ u j# 2 "r iµ r iµ, j# j# 0 And the equation of motion for an atom is, m i d 2 u iµ dt 2 = " % j$ # 2 U #r iµ r j$ 0 u j$

9 Eigenvalue equation Assuming a single normal mode excited, we find from Eq. of motion $ " % = ' 2 % iµ, j# j#,& & iµ,& j# The force-constant matrix is given by " iµ, j# = 2 U 1 $ ( m m ) 1/ 2 $r r i j iµ j# 0 Related to Hessian, just including the masses of the atoms

10 General procedure 1. Choose a volume V 2. Compute Hessian --> force constant matrix 3. Diagonalize real-symmetric matrix 4. Compute free energy F(V,T) for various temperatures 5. Return to 1. This should allow us to generate F(V,T) curves Plot F(V,T) vs. volume V for various temperatures Find minimum by fitting to Eq. of state Thermal expansion. Anharmonicity through dependence of modes on V Usually called quasi-harmonic approximation

11 Declarations, Equation of state code! Program to compute the free energy for a lennard jones solid IMPLICIT NONE INTEGER, PARAMETER :: nn=4 INTEGER, PARAMETER :: Prec14=SELECTED_REAL_KIND(14) REAL(KIND=Prec14), PARAMETER :: L0=2.0d0**(2.0d0/3.0d0)*nn,temp=100.0d0 INTEGER, PARAMETER :: nvol=25 INTEGER, PARAMETER :: natoms=4*nn**3,ndim=3*natoms INTEGER, PARAMETER :: nx=nn,ny=nn,nz=nn INTEGER :: i,j,ix,iy,iz,mu,nu,m,n,matz,m1,n1,ierr REAL(KIND=Prec14), PARAMETER :: sigma=1.0d0,epsilon=1.0d0 REAL(KIND=Prec14), PARAMETER :: amass=1.0d0 REAL(KIND=Prec14), PARAMETER :: rcut=3.0d0*sigma REAL(KIND=Prec14) :: epot,dvdr,dvdr2,pi,fac,free,dvol,vmin,vmax,l REAL(KIND=Prec14) :: sxij,syij,szij,rij,sovr,volume,nv REAL(KIND=Prec14), DIMENSION(4) :: r1,r2,r3 REAL(KIND=Prec14), DIMENSION(3) :: s REAL(KIND=Prec14), DIMENSION(natoms) :: rx,ry,rz REAL(KIND=Prec14), DIMENSION(ndim,ndim) :: hess,z REAL(KIND=Prec14), DIMENSION(ndim) :: w,fv1,fv2 REAL(KIND=Prec14), PARAMETER :: mass=39.948d0,eps=120.0d0,sar=3.4d0

12 Some preliminaries Need to compute at several volumes, one temperature Also need to zero Hessian for calculations pi=4.0d0*datan(1.0d0)! Compute volume volume=l0**3 vmin=volume*0.85d0 vmax=volume*1.05d0 dvol=(vmax-vmin)/(nvol-1) Then put the atoms on the fcc lattice as in MD code (see several slides previous)

13 Do loop on the volumes, several volumes do nv=1,nvol! Clear the hessian out hess=0.0d0 epot=0.0d0! set potential energy to zero volume=vmin+(nv-1)*dvol L=volume**(1.0d0/3.0d0)

14 Loop on all atom pairs, compute for rij<rcut do i=1,natoms-1 do j=i+1,natoms sxij=rx(i)-rx(j) syij=ry(i)-ry(j) szij=rz(i)-rz(j) sxij=sxij-dble(anint(sxij)) syij=syij-dble(anint(syij)) Added a 1/rij here compared to forces szij=szij-dble(anint(szij)) sxij=sxij*l; syij=syij*l; szij=szij*l rij=dsqrt(sxij**2+syij**2+szij**2) s(1)=sxij/rij; s(2)=syij/rij; s(3)=szij/rij if(rij.lt.rcut) then sovr=sigma/rij epot=epot+4.0d0*epsilon*(sovr**12-sovr**6) dvdr=-(24.0d0*epsilon/rij**2)*(2.0d0*sovr**12-sovr**6) dvdr2=(24.0d0*epsilon/rij**2)*(26.0d0*sovr**12-7.0d0*sovr**6) New lines, first and second derivative of V with respect to r

15 Identifying atom numbers with matrix elements 3N degrees of freedom (x,y,z, corresponding to µ=1,2,3) Atom #1 1,2,3 Atom #2 4,5,6 Etc. Then for atom number i, component mu: m=3*(i-1)+mu For atom j, component nu: n=3*(j-1)+nu Then we can fill matrix element hess(i,j)

16 Implement. do mu=1,3 do nu=1,3 m=(i-1)*3+mu n=(j-1)*3+nu if(mu.eq.nu) hess(m,n)=-dvdr2*s(mu)*s(nu)+dvdr*(s(mu)*s(nu)-1.0d0) if(mu.ne.nu) hess(m,n)=-dvdr2*s(mu)*s(nu)+dvdr*s(mu)*s(nu) hess(m,n)=hess(m,n)/amass hess(n,m)=hess(m,n)! Matrix needs to be symmetric, and we are only using eac. Need to add then terms for H iµ,jν m1=(i-1)*3+mu n1=(i-1)*3+nu hess(m1,n1)=hess(m1,n1)-hess(m,n) m1=(j-1)*3+mu n1=(j-1)*3+nu hess(m1,n1)=hess(m1,n1)-hess(m,n) Diagonalize using the subroutine rs, once hess is filled

17 What do you get? call rs(ndim,ndim,hess,w,matz,z,fv1,fv2,ierr) Eigenvalues are the ω 2 for each of the 3N modes First three should be nearly zero might be slightly negative Next ones should all be greater than zero (in general) Units can be found in THz (for example) w(n)=dsqrt(w(n))! Find frequencies from eigenvalues! Convert frequency to a unit in THz fac=dsqrt((1.381d0*6.022d0*eps)/(10.0d0*mass*sar**2)) w(n)=w(n)*fac/(2.0d0*pi)

18 What do you get? Eigenvalues are the ω 2 for each of the 3N modes First three should be nearly zero might be slightly negative Next ones should all be greater than zero (in general) Units can be found in THz (for example) w(n)=dsqrt(w(n))! Find frequencies from eigenvalues! Convert frequency to a unit in THz fac=dsqrt((1.381d0*6.022d0*eps)/(10.0d0*mass*sar**2)) w(n)=w(n)*fac/(2.0d0*pi) fac=(1.381d-4/1.602d0)! kb in ev/k epot=epot*eps*fac free=epot do n=4,ndim! sum on eigenvalues free=free+fac*temp*dlog(2.0d0*dsinh(w(n)/(2.0d0*fac*temp))) enddo free=free/natoms write(6,100) volume*sar**3/natoms,free

19 Birch-Murnaghan equation of state Determine equilibrium volume V 0, Bulk modulus Murnaghan: $ p = "& #F %#V ' ) ( T $ B = "V & #p %#V ' ) ( T Experimentally, it is found that B varies with pressure B = B 0 + " B p Combining these and integrating, we get p(v ) = B 0 " B *#,% + $ V 0 V B & 0 " - ( )1/ '.

20 Birch-Murnaghan equation of state A slightly more sophisticated expression is: Birch-Murnaghan: p = 3B 0 2 )" + $ *# V 0 V % ' & 7 / 3 " ( V % 0 $ ' # V & 5 / 3, ( B 0 / ( 4) )" + $ *# V 0 V % ' & 2 / 3, 42 ( After integrating we get F = F 0 + 9V 0 B )" 1 + $ *# 32 V 0 V % ' & 2 / 3, ( )" B 0 / + V % 0 + $ ' *# V & 2 / 3, ( ) " 6 ( 4 V % 0 + $ ' * # V & 2 / 3, Equilibrium (p=0) volume is V 0 B 0 is bulk modulus at p=0 F 0, V 0, B 0 are fitting parameters Monte Carlo code to do fitting exists

21 Free energy vs. volume T=5K T=10K T=50K T=100K Thermal expansion, V 0 increases with temperature Curvature related to bulk modulus B Vibrational energy/entropy

22 ! get initial direction h h=g! output current potential energy After Hessian and intial direction g found write(6,*) 'Hessian computed, potential energy=',epot! compute lambda lambda=0.0d0 do n=1,ndim lambda=lambda+g(n)*g(n) enddo vec=0.0d0 do m=1,ndim do n=1,ndim vec(m)=vec(m)+hess(m,n)*h(n) enddo enddo denom=0.0d0 do m=1,ndim denom=denom+h(m)*vec(m) enddo

ab initio Lattice Vibrations: Calculating the Thermal Expansion Coeffcient Felix Hanke & Martin Fuchs June 30, 2009 This afternoon s plan

ab initio Lattice Vibrations: Calculating the Thermal Expansion Coeffcient Felix Hanke & Martin Fuchs June 30, 2009 This afternoon s plan ab initio Lattice Vibrations: Calculating the Thermal Expansion Coeffcient Felix Hanke & Martin Fuchs June 3, 29 This afternoon s plan introductory talk Phonons: harmonic vibrations for solids Phonons:

More information

Introduction to solid state physics

Introduction to solid state physics PHYS 342/555 Introduction to solid state physics Instructor: Dr. Pengcheng Dai Professor of Physics The University of Tennessee (Room 407A, Nielsen, 974-1509) Chapter 5: Thermal properties Lecture in pdf

More information

Functions of Several Variables

Functions of Several Variables Functions of Several Variables The Unconstrained Minimization Problem where In n dimensions the unconstrained problem is stated as f() x variables. minimize f()x x, is a scalar objective function of vector

More information

Structural Calculations phase stability, surfaces, interfaces etc

Structural Calculations phase stability, surfaces, interfaces etc Structural Calculations phase stability, surfaces, interfaces etc Keith Refson STFC Rutherford Appleton Laboratory September 19, 2007 Phase Equilibrium 2 Energy-Volume curves..................................................................

More information

TUTORIAL 6: PHONONS, LATTICE EXPANSION, AND BAND-GAP RENORMALIZATION

TUTORIAL 6: PHONONS, LATTICE EXPANSION, AND BAND-GAP RENORMALIZATION Hands-On Tutorial Workshop, July 29 th 2014 TUTORIAL 6: PHONONS, LATTICE EXPANSION, AND BAND-GAP RENORMALIZATION Christian Carbogno & Manuel Schöttler Fritz-Haber-Institut der Max-Planck-Gesellschaft,

More information

TUTORIAL 8: PHONONS, LATTICE EXPANSION, AND BAND-GAP RENORMALIZATION

TUTORIAL 8: PHONONS, LATTICE EXPANSION, AND BAND-GAP RENORMALIZATION TUTORIAL 8: PHONONS, LATTICE EXPANSION, AND BAND-GAP RENORMALIZATION 1 INVESTIGATED SYSTEM: Silicon, diamond structure Electronic and 0K properties see W. Huhn, Tutorial 2, Wednesday August 2 2 THE HARMONIC

More information

Crystal Relaxation, Elasticity, and Lattice Dynamics

Crystal Relaxation, Elasticity, and Lattice Dynamics http://exciting-code.org Crystal Relaxation, Elasticity, and Lattice Dynamics Pasquale Pavone Humboldt-Universität zu Berlin http://exciting-code.org PART I: Structure Optimization Pasquale Pavone Humboldt-Universität

More information

1 Bulk Simulations in a HCP lattice

1 Bulk Simulations in a HCP lattice 1 Bulk Simulations in a HCP lattice 1.1 Introduction This project is a continuation of two previous projects that studied the mechanism of melting in a FCC and BCC lattice. The current project studies

More information

Linear Algebra. Linear Equations and Matrices. Copyright 2005, W.R. Winfrey

Linear Algebra. Linear Equations and Matrices. Copyright 2005, W.R. Winfrey Copyright 2005, W.R. Winfrey Topics Preliminaries Systems of Linear Equations Matrices Algebraic Properties of Matrix Operations Special Types of Matrices and Partitioned Matrices Matrix Transformations

More information

Phonons and lattice dynamics

Phonons and lattice dynamics Chapter Phonons and lattice dynamics. Vibration modes of a cluster Consider a cluster or a molecule formed of an assembly of atoms bound due to a specific potential. First, the structure must be relaxed

More information

Structure of Defective Crystals at Finite Temperatures: A Quasi-Harmonic Lattice Dynamics Approach

Structure of Defective Crystals at Finite Temperatures: A Quasi-Harmonic Lattice Dynamics Approach Structure of Defective Crystals at Finite Temperatures: A Quasi-Harmonic Lattice Dynamics Approach Arash Yavari Arzhang Angoshtari Abstract In this paper we extend the classical method of lattice dynamics

More information

+ V = 0, j = 1,..., 3N (7.1) i =1, 3 m = 1, N, X mi, V X mi. i = 0 in the equilibrium. X mi X nj

+ V = 0, j = 1,..., 3N (7.1) i =1, 3 m = 1, N, X mi, V X mi. i = 0 in the equilibrium. X mi X nj 7. Lattice dynamics 7.1 Basic consideratons In this section we ll follow a number of well-known textbooks, and only try to keep the notations consistent. Suppose we have a system of N atoms, m=1,...,n,

More information

Thermodynamics of Solids: Harmonic and Quasi-harmonic Approximations

Thermodynamics of Solids: Harmonic and Quasi-harmonic Approximations Thermodynamics of Solids: Harmonic and Quasi-harmonic Approximations, USA, July 9-14, 2017 Alessandro Erba Dipartimento di Chimica, Università di Torino (Italy) alessandro.erba@unito.it 2017 Outline -

More information

ON THE INTEGRATION OF EQUATIONS OF MOTION: FEM AND MOLECULAR DYNAMICS PROBLEMS

ON THE INTEGRATION OF EQUATIONS OF MOTION: FEM AND MOLECULAR DYNAMICS PROBLEMS 8th International Congress on Computational Mechanics, Volos, 1-15 July 015 ON THE INTEGRATION OF EQUATIONS OF MOTION: FEM AND MOLECULAR DYNAMICS PROBLEMS E.G. Kakouris, V.K. Koumousis Institute of Structural

More information

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

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

More information

Vasil Khalidov & Miles Hansard. C.M. Bishop s PRML: Chapter 5; Neural Networks

Vasil Khalidov & Miles Hansard. C.M. Bishop s PRML: Chapter 5; Neural Networks C.M. Bishop s PRML: Chapter 5; Neural Networks Introduction The aim is, as before, to find useful decompositions of the target variable; t(x) = y(x, w) + ɛ(x) (3.7) t(x n ) and x n are the observations,

More information

Physics 4022 Notes on Density Matrices

Physics 4022 Notes on Density Matrices Physics 40 Notes on Density Matrices Definition: For a system in a definite normalized state ψ > the density matrix ρ is ρ = ψ >< ψ 1) From Eq 1 it is obvious that in the basis defined by ψ > and other

More information

AA 242B / ME 242B: Mechanical Vibrations (Spring 2016)

AA 242B / ME 242B: Mechanical Vibrations (Spring 2016) AA 242B / ME 242B: Mechanical Vibrations (Spring 206) Solution of Homework #3 Control Tab Figure : Schematic for the control tab. Inadequacy of a static-test A static-test for measuring θ would ideally

More information

Phonon Dispersion, Interatomic Force Constants Thermodynamic Quantities

Phonon Dispersion, Interatomic Force Constants Thermodynamic Quantities Phonon Dispersion, Interatomic Force Constants Thermodynamic Quantities Umesh V. Waghmare Theoretical Sciences Unit J N C A S R Bangalore ICMR OUTLINE Vibrations and interatomic force constants (IFC) Extended

More information

Pair Potentials and Force Calculations

Pair Potentials and Force Calculations Molecular Dynamics simulations Lecture 04: Pair Potentials and Force Calculations Dr. Olli Pakarinen University of Helsinki Fall 01 Lecture notes based on notes by Dr. Jani Kotakoski, 010 CONSTRUCTING

More information

Supplementary Information

Supplementary Information Supplementary Information Ballistic Thermal Transport in Carbyne and Cumulene with Micron-Scale Spectral Acoustic Phonon Mean Free Path Mingchao Wang and Shangchao Lin * Department of Mechanical Engineering,

More information

Interatomic Potentials. The electronic-structure problem

Interatomic Potentials. The electronic-structure problem Interatomic Potentials Before we can start a simulation, we need the model! Interaction between atoms and molecules is determined by quantum mechanics: Schrödinger Equation + Born-Oppenheimer approximation

More information

Quasiharmonic models for the calculation of thermodynamic properties of crystalline silicon under strain

Quasiharmonic models for the calculation of thermodynamic properties of crystalline silicon under strain JOURNAL OF APPLIED PHYSICS 99, 64314 26 Quasiharmonic models for the calculation of thermodynamic properties of crystalline silicon under strain H. Zhao and Z. Tang Department of Mechanical and Industrial

More information

Solid State Physics II Lattice Dynamics and Heat Capacity

Solid State Physics II Lattice Dynamics and Heat Capacity SEOUL NATIONAL UNIVERSITY SCHOOL OF PHYSICS http://phya.snu.ac.kr/ ssphy2/ SPRING SEMESTER 2004 Chapter 3 Solid State Physics II Lattice Dynamics and Heat Capacity Jaejun Yu jyu@snu.ac.kr http://phya.snu.ac.kr/

More information

Exploring the energy landscape

Exploring the energy landscape Exploring the energy landscape ChE210D Today's lecture: what are general features of the potential energy surface and how can we locate and characterize minima on it Derivatives of the potential energy

More information

Handout 10. Applications to Solids

Handout 10. Applications to Solids ME346A Introduction to Statistical Mechanics Wei Cai Stanford University Win 2011 Handout 10. Applications to Solids February 23, 2011 Contents 1 Average kinetic and potential energy 2 2 Virial theorem

More information

Phonon wavefunctions and electron phonon interactions in semiconductors

Phonon wavefunctions and electron phonon interactions in semiconductors Phonon wavefunctions and electron phonon interactions in semiconductors Bartomeu Monserrat bm418@cam.ac.uk University of Cambridge Quantum Monte Carlo in the Apuan Alps VII QMC in the Apuan Alps VII Bartomeu

More information

Phonons (Classical theory)

Phonons (Classical theory) Phonons (Classical theory) (Read Kittel ch. 4) Classical theory. Consider propagation of elastic waves in cubic crystal, along [00], [0], or [] directions. Entire plane vibrates in phase in these directions

More information

Symmetry and Properties of Crystals (MSE638) Stress and Strain Tensor

Symmetry and Properties of Crystals (MSE638) Stress and Strain Tensor Symmetry and Properties of Crystals (MSE638) Stress and Strain Tensor Somnath Bhowmick Materials Science and Engineering, IIT Kanpur April 6, 2018 Tensile test and Hooke s Law Upto certain strain (0.75),

More information

Lattice Vibrations. Chris J. Pickard. ω (cm -1 ) 200 W L Γ X W K K W

Lattice Vibrations. Chris J. Pickard. ω (cm -1 ) 200 W L Γ X W K K W Lattice Vibrations Chris J. Pickard 500 400 300 ω (cm -1 ) 200 100 L K W X 0 W L Γ X W K The Breakdown of the Static Lattice Model The free electron model was refined by introducing a crystalline external

More information

I = i 0,

I = i 0, Special Types of Matrices Certain matrices, such as the identity matrix 0 0 0 0 0 0 I = 0 0 0, 0 0 0 have a special shape, which endows the matrix with helpful properties The identity matrix is an example

More information

Physics 211B : Problem Set #0

Physics 211B : Problem Set #0 Physics 211B : Problem Set #0 These problems provide a cross section of the sort of exercises I would have assigned had I taught 211A. Please take a look at all the problems, and turn in problems 1, 4,

More information

1 Determinants. 1.1 Determinant

1 Determinants. 1.1 Determinant 1 Determinants [SB], Chapter 9, p.188-196. [SB], Chapter 26, p.719-739. Bellow w ll study the central question: which additional conditions must satisfy a quadratic matrix A to be invertible, that is to

More information

Tight-binding molecular dynamics study of palladium

Tight-binding molecular dynamics study of palladium PHYSICAL REVIEW B 79, 064107 2009 Tight-binding molecular dynamics study of palladium A. Shabaev and D. A. Papaconstantopoulos George Mason University, Fairfax, Virginia 22030, USA Received 24 September

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 + 1 v i t n v i t n + 1 Perform T, P

More information

III.H Zeroth Order Hydrodynamics

III.H Zeroth Order Hydrodynamics III.H Zeroth Order Hydrodynamics As a first approximation, we shall assume that in local equilibrium, the density f 1 at each point in space can be represented as in eq.(iii.56), i.e. [ ] p m q, t)) f

More information

One-shot free energy calculations for crystalline materials

One-shot free energy calculations for crystalline materials Instability One-shot free energy calculations for crystalline materials Thesis for the Degree Master of Science TOMMY ANDERSSON Department of Applied Physics Chalmers University of Technology Gothenburg,

More information

Using the Anharmonic Correclated Einstein Model for Calculation the Thermodynamic Parameters and Cumulants of Dopant Face Cubic Center Crystals

Using the Anharmonic Correclated Einstein Model for Calculation the Thermodynamic Parameters and Cumulants of Dopant Face Cubic Center Crystals AASCIT Journal of Physics 015; 1(1: 1-5 Published online March 0, 015 (http://www.aascit.org/journal/physics Using the Anharmonic Correclated instein Model for Calculation the Thermodynamic Parameters

More information

Quantum Theory of Matter

Quantum Theory of Matter Imperial College London Department of Physics Professor Ortwin Hess o.hess@imperial.ac.uk Quantum Theory of Matter Spring 014 1 Periodic Structures 1.1 Direct and Reciprocal Lattice (a) Show that the reciprocal

More information

Matrix Algebra & Elementary Matrices

Matrix Algebra & Elementary Matrices Matrix lgebra & Elementary Matrices To add two matrices, they must have identical dimensions. To multiply them the number of columns of the first must equal the number of rows of the second. The laws below

More information

Chapter 5 Phonons II Thermal Properties

Chapter 5 Phonons II Thermal Properties Chapter 5 Phonons II Thermal Properties Phonon Heat Capacity < n k,p > is the thermal equilibrium occupancy of phonon wavevector K and polarization p, Total energy at k B T, U = Σ Σ < n k,p > ħ k, p Plank

More information

Potentials, periodicity

Potentials, periodicity Potentials, periodicity Lecture 2 1/23/18 1 Survey responses 2 Topic requests DFT (10), Molecular dynamics (7), Monte Carlo (5) Machine Learning (4), High-throughput, Databases (4) NEB, phonons, Non-equilibrium

More information

Dispersion relation for transverse waves in a linear chain of particles

Dispersion relation for transverse waves in a linear chain of particles Dispersion relation for transverse waves in a linear chain of particles V. I. Repchenkov* It is difficult to overestimate the importance that have for the development of science the simplest physical and

More information

Introduction to Geometry Optimization. Computational Chemistry lab 2009

Introduction to Geometry Optimization. Computational Chemistry lab 2009 Introduction to Geometry Optimization Computational Chemistry lab 9 Determination of the molecule configuration H H Diatomic molecule determine the interatomic distance H O H Triatomic molecule determine

More information

Phonons II - Thermal Properties (Kittel Ch. 5)

Phonons II - Thermal Properties (Kittel Ch. 5) Phonons II - Thermal Properties (Kittel Ch. 5) Heat Capacity C T 3 Approaches classical limit 3 N k B T Physics 460 F 2006 Lect 10 1 Outline What are thermal properties? Fundamental law for probabilities

More information

Relevance of jamming to the mechanical properties of solids Sidney Nagel University of Chicago Capri; September 12, 2014

Relevance of jamming to the mechanical properties of solids Sidney Nagel University of Chicago Capri; September 12, 2014 Relevance of jamming to the mechanical properties of solids Sidney Nagel University of Chicago Capri; September 1, 014 What is role of (dis)order for mechanical behavior? Andrea J. Liu Carl Goodrich Justin

More information

Crystals. Peter Košovan. Dept. of Physical and Macromolecular Chemistry

Crystals. Peter Košovan. Dept. of Physical and Macromolecular Chemistry Crystals Peter Košovan peter.kosovan@natur.cuni.cz Dept. of Physical and Macromolecular Chemistry Lecture 1, Statistical Thermodynamics, MC26P15, 5.1.216 If you find a mistake, kindly report it to the

More information

AA242B: MECHANICAL VIBRATIONS

AA242B: MECHANICAL VIBRATIONS AA242B: MECHANICAL VIBRATIONS 1 / 50 AA242B: MECHANICAL VIBRATIONS Undamped Vibrations of n-dof Systems These slides are based on the recommended textbook: M. Géradin and D. Rixen, Mechanical Vibrations:

More information

Chemistry 365: Normal Mode Analysis David Ronis McGill University

Chemistry 365: Normal Mode Analysis David Ronis McGill University Chemistry 365: Normal Mode Analysis David Ronis McGill University 1. Quantum Mechanical Treatment Our starting point is the Schrodinger wave equation: Σ h 2 2 2m i N i=1 r 2 i + U( r 1,..., r N ) Ψ( r

More information

Density functional theory and beyond: Computational materials science for real materials Los Angeles, July 21 August 1, 2014

Density functional theory and beyond: Computational materials science for real materials Los Angeles, July 21 August 1, 2014 Density functional theory and beyond: Computational materials science for real materials Los Angeles, July 21 August 1, 2014 R L e y E N e x Tutorial VI: Phonons, Lattice Expansion, and Band-gap Renormalization

More information

Phonon II Thermal Properties

Phonon II Thermal Properties Phonon II Thermal Properties Physics, UCF OUTLINES Phonon heat capacity Planck distribution Normal mode enumeration Density of states in one dimension Density of states in three dimension Debye Model for

More information

1 The Quantum Anharmonic Oscillator

1 The Quantum Anharmonic Oscillator 1 The Quantum Anharmonic Oscillator Perturbation theory based on Feynman diagrams can be used to calculate observables in Quantum Electrodynamics, like the anomalous magnetic moment of the electron, and

More information

Chapter 5: Thermal Properties of Crystal Lattices

Chapter 5: Thermal Properties of Crystal Lattices Chapter 5: Thermal Properties of Crystal Lattices Debye January 30, 07 Contents Formalism. The Virial Theorem............................. The Phonon Density of States...................... 5 Models of

More information

arxiv:cond-mat/ v1 [cond-mat.mtrl-sci] 14 May 2003

arxiv:cond-mat/ v1 [cond-mat.mtrl-sci] 14 May 2003 LA-UR-3-239 arxiv:cond-mat/35331v1 [cond-mat.mtrl-sci] 14 May 23 Thermal Stabilization of the HCP Phase in Titanium Sven P. Rudin 1, M. D. Jones 2, and R. C. Albers 1 1 Los Alamos National Laboratory,

More information

Introduction to density functional perturbation theory for lattice dynamics

Introduction to density functional perturbation theory for lattice dynamics Introduction to density functional perturbation theory for lattice dynamics SISSA and DEMOCRITOS Trieste (Italy) Outline 1 Lattice dynamic of a solid: phonons Description of a solid Equations of motion

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

Identification Methods for Structural Systems. Prof. Dr. Eleni Chatzi Lecture March, 2016

Identification Methods for Structural Systems. Prof. Dr. Eleni Chatzi Lecture March, 2016 Prof. Dr. Eleni Chatzi Lecture 4-09. March, 2016 Fundamentals Overview Multiple DOF Systems State-space Formulation Eigenvalue Analysis The Mode Superposition Method The effect of Damping on Structural

More information

Supporting Online Material (1)

Supporting Online Material (1) Supporting Online Material The density functional theory (DFT) calculations were carried out using the dacapo code (http://www.fysik.dtu.dk/campos), and the RPBE (1) generalized gradient correction (GGA)

More information

Electronic Squeezing by Optically Pumped Phonons: Transient Superconductivity in K 3 C 60. With: Eli Wilner Dante Kennes Andrew Millis

Electronic Squeezing by Optically Pumped Phonons: Transient Superconductivity in K 3 C 60. With: Eli Wilner Dante Kennes Andrew Millis Electronic Squeezing by Optically Pumped Phonons: Transient Superconductivity in K 3 C 60 With: Eli Wilner Dante Kennes Andrew Millis Background: Mean-Field Theory of Simple Superconductivity If the effective

More information

Lecture 11 - Phonons II - Thermal Prop. Continued

Lecture 11 - Phonons II - Thermal Prop. Continued Phonons II - hermal Properties - Continued (Kittel Ch. 5) Low High Outline Anharmonicity Crucial for hermal expansion other changes with pressure temperature Gruneisen Constant hermal Heat ransport Phonon

More information

Lecture 12: Phonon heat capacity

Lecture 12: Phonon heat capacity Lecture 12: Phonon heat capacity Review o Phonon dispersion relations o Quantum nature of waves in solids Phonon heat capacity o Normal mode enumeration o Density of states o Debye model Review By considering

More information

Lecture 9 Anharmonic effects in crystals.

Lecture 9 Anharmonic effects in crystals. Lecture 9 Anharmonic effects in crystals. 1 Introduction Most of the effects related to lattice dynamics that you have so far encountered in this course and in previous courses lattice specific heat, Debye-Waller

More information

The quasi-harmonic approximation (QHA)

The quasi-harmonic approximation (QHA) The quasi-harmonic approximation (QHA) M. Palumbo 19/01/2017 Trieste, Italy Limitations of the harmonic approximation E tot(r I, u I )=E tot(r I )+ I,α E tot u u Iα + 1 2 E tot Iα 2 I,α u u Iα u Iα u Jβ

More information

The goal of equilibrium statistical mechanics is to calculate the diagonal elements of ˆρ eq so we can evaluate average observables < A >= Tr{Â ˆρ eq

The goal of equilibrium statistical mechanics is to calculate the diagonal elements of ˆρ eq so we can evaluate average observables < A >= Tr{Â ˆρ eq Chapter. The microcanonical ensemble The goal of equilibrium statistical mechanics is to calculate the diagonal elements of ˆρ eq so we can evaluate average observables < A >= Tr{Â ˆρ eq } = A that give

More information

Introduction to Quantitative Techniques for MSc Programmes SCHOOL OF ECONOMICS, MATHEMATICS AND STATISTICS MALET STREET LONDON WC1E 7HX

Introduction to Quantitative Techniques for MSc Programmes SCHOOL OF ECONOMICS, MATHEMATICS AND STATISTICS MALET STREET LONDON WC1E 7HX Introduction to Quantitative Techniques for MSc Programmes SCHOOL OF ECONOMICS, MATHEMATICS AND STATISTICS MALET STREET LONDON WC1E 7HX September 2007 MSc Sep Intro QT 1 Who are these course for? The September

More information

April 26, Applied mathematics PhD candidate, physics MA UC Berkeley. Lecture 4/26/2013. Jed Duersch. Spd matrices. Cholesky decomposition

April 26, Applied mathematics PhD candidate, physics MA UC Berkeley. Lecture 4/26/2013. Jed Duersch. Spd matrices. Cholesky decomposition Applied mathematics PhD candidate, physics MA UC Berkeley April 26, 2013 UCB 1/19 Symmetric positive-definite I Definition A symmetric matrix A R n n is positive definite iff x T Ax > 0 holds x 0 R n.

More information

Differentiable Functions

Differentiable Functions Differentiable Functions Let S R n be open and let f : R n R. We recall that, for x o = (x o 1, x o,, x o n S the partial derivative of f at the point x o with respect to the component x j is defined as

More information

Chapter 2: Rigid Bar Supported by Two Buckled Struts under Axial, Harmonic, Displacement Excitation..14

Chapter 2: Rigid Bar Supported by Two Buckled Struts under Axial, Harmonic, Displacement Excitation..14 Table of Contents Chapter 1: Research Objectives and Literature Review..1 1.1 Introduction...1 1.2 Literature Review......3 1.2.1 Describing Vibration......3 1.2.2 Vibration Isolation.....6 1.2.2.1 Overview.

More information

Phonons I - Crystal Vibrations (Kittel Ch. 4)

Phonons I - Crystal Vibrations (Kittel Ch. 4) Phonons I - Crystal Vibrations (Kittel Ch. 4) Displacements of Atoms Positions of atoms in their perfect lattice positions are given by: R 0 (n 1, n 2, n 3 ) = n 10 x + n 20 y + n 30 z For simplicity here

More information

MSE 561, Atomic Modeling in Material Science Assignment 2

MSE 561, Atomic Modeling in Material Science Assignment 2 Department of Material Science and Engineering, University of Pennsylvania MSE 561, Atomic Modeling in Material Science Assignment 2 1. Construction of the Two-dimensional Block As derived in Assignment

More information

The Dulong-Petit (1819) rule for molar heat capacities of crystalline matter c v, predicts the constant value

The Dulong-Petit (1819) rule for molar heat capacities of crystalline matter c v, predicts the constant value I believe that nobody who has a reasonably reliable sense for the experimental test of a theory will be able to contemplate these results without becoming convinced of the mighty logical power of the quantum

More information

Ma 227 Review for Systems of DEs

Ma 227 Review for Systems of DEs Ma 7 Review for Systems of DEs Matrices Basic Properties Addition and subtraction: Let A a ij mn and B b ij mn.then A B a ij b ij mn 3 A 6 B 6 4 7 6 A B 6 4 3 7 6 6 7 3 Scaler Multiplication: Let k be

More information

Chapter 4 - MATRIX ALGEBRA. ... a 2j... a 2n. a i1 a i2... a ij... a in

Chapter 4 - MATRIX ALGEBRA. ... a 2j... a 2n. a i1 a i2... a ij... a in Chapter 4 - MATRIX ALGEBRA 4.1. Matrix Operations A a 11 a 12... a 1j... a 1n a 21. a 22.... a 2j... a 2n. a i1 a i2... a ij... a in... a m1 a m2... a mj... a mn The entry in the ith row and the jth column

More information

Pre-yield non-affine fluctuations and a hidden critical point in strained crystals

Pre-yield non-affine fluctuations and a hidden critical point in strained crystals Supplementary Information for: Pre-yield non-affine fluctuations and a hidden critical point in strained crystals Tamoghna Das, a,b Saswati Ganguly, b Surajit Sengupta c and Madan Rao d a Collective Interactions

More information

An Introduction to Lattice Vibrations

An Introduction to Lattice Vibrations An Introduction to Lattice Vibrations Andreas Wacker 1 Mathematical Physics, Lund University November 3, 2015 1 Introduction Ideally, the atoms in a crystal are positioned in a regular manner following

More information

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

Set the initial conditions r i. Update neighborlist. 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 + 1 ) v i ( t n )

More information

Molecular Dynamics. The Molecular Dynamics (MD) method for classical systems (not H or He)

Molecular Dynamics. The Molecular Dynamics (MD) method for classical systems (not H or He) Molecular Dynamics What to choose in an integrator The Verlet algorithm Boundary Conditions in Space and time Reading Assignment: F&S Chapter 4 1 The Molecular Dynamics (MD) method for classical systems

More information

Before we start: Important setup of your Computer

Before we start: Important setup of your Computer Before we start: Important setup of your Computer change directory: cd /afs/ictp/public/shared/smr2475./setup-config.sh logout login again 1 st Tutorial: The Basics of DFT Lydia Nemec and Oliver T. Hofmann

More information

For a system with more than one electron, we can t solve the Schrödinger Eq. exactly. We must develop methods of approximation, such as

For a system with more than one electron, we can t solve the Schrödinger Eq. exactly. We must develop methods of approximation, such as VARIATIO METHOD For a system with more than one electron, we can t solve the Schrödinger Eq. exactly. We must develop methods of approximation, such as Variation Method Perturbation Theory Combination

More information

Physical Chemistry Laboratory II (CHEM 337) EXPT 9 3: Vibronic Spectrum of Iodine (I2)

Physical Chemistry Laboratory II (CHEM 337) EXPT 9 3: Vibronic Spectrum of Iodine (I2) Physical Chemistry Laboratory II (CHEM 337) EXPT 9 3: Vibronic Spectrum of Iodine (I2) Obtaining fundamental information about the nature of molecular structure is one of the interesting aspects of molecular

More information

Exact diagonalization methods

Exact diagonalization methods Summer School on Computational Statistical Physics August 4-11, 2010, NCCU, Taipei, Taiwan Exact diagonalization methods Anders W. Sandvik, Boston University Representation of states in the computer bit

More information

Formalism of the Tersoff potential

Formalism of the Tersoff potential Originally written in December 000 Translated to English in June 014 Formalism of the Tersoff potential 1 The original version (PRB 38 p.990, PRB 37 p.6991) Potential energy Φ = 1 u ij i (1) u ij = f ij

More information

PHY217: Vibrations and Waves

PHY217: Vibrations and Waves Assessed Problem set 1 Issued: 5 November 01 PHY17: Vibrations and Waves Deadline for submission: 5 pm Thursday 15th November, to the V&W pigeon hole in the Physics reception on the 1st floor of the GO

More information

Hanoi 7/11/2018. Ngo Van Thanh, Institute of Physics, Hanoi, Vietnam.

Hanoi 7/11/2018. Ngo Van Thanh, Institute of Physics, Hanoi, Vietnam. Hanoi 7/11/2018 Ngo Van Thanh, Institute of Physics, Hanoi, Vietnam. Finite size effects and Reweighting methods 1. Finite size effects 2. Single histogram method 3. Multiple histogram method 4. Wang-Landau

More information

Chapter 2 Experimental sources of intermolecular potentials

Chapter 2 Experimental sources of intermolecular potentials Chapter 2 Experimental sources of intermolecular potentials 2.1 Overview thermodynamical properties: heat of vaporization (Trouton s rule) crystal structures ionic crystals rare gas solids physico-chemical

More information

Coarse-graining molecular dynamics in crystalline solids

Coarse-graining molecular dynamics in crystalline solids in crystalline solids Xiantao Li Department of Mathematics Penn State University. July 19, 2009. General framework Outline 1. Motivation and Problem setup 2. General methodology 3. The derivation of the

More information

Rotations and vibrations of polyatomic molecules

Rotations and vibrations of polyatomic molecules Rotations and vibrations of polyatomic molecules When the potential energy surface V( R 1, R 2,..., R N ) is known we can compute the energy levels of the molecule. These levels can be an effect of: Rotation

More information

Section 9.2: Matrices.. a m1 a m2 a mn

Section 9.2: Matrices.. a m1 a m2 a mn Section 9.2: Matrices Definition: A matrix is a rectangular array of numbers: a 11 a 12 a 1n a 21 a 22 a 2n A =...... a m1 a m2 a mn In general, a ij denotes the (i, j) entry of A. That is, the entry in

More information

Accuracy and transferability of GAP models for tungsten

Accuracy and transferability of GAP models for tungsten Accuracy and transferability of GAP models for tungsten Wojciech J. Szlachta Albert P. Bartók Gábor Csányi Engineering Laboratory University of Cambridge 5 November 214 Motivation Number of atoms 1 1 2

More information

Physics with Neutrons I, WS 2015/2016. Lecture 11, MLZ is a cooperation between:

Physics with Neutrons I, WS 2015/2016. Lecture 11, MLZ is a cooperation between: Physics with Neutrons I, WS 2015/2016 Lecture 11, 11.1.2016 MLZ is a cooperation between: Organization Exam (after winter term) Registration: via TUM-Online between 16.11.2015 15.1.2015 Email: sebastian.muehlbauer@frm2.tum.de

More information

Solving Linear Systems of Equations

Solving Linear Systems of Equations November 6, 2013 Introduction The type of problems that we have to solve are: Solve the system: A x = B, where a 11 a 1N a 12 a 2N A =.. a 1N a NN x = x 1 x 2. x N B = b 1 b 2. b N To find A 1 (inverse

More information

Department of Chemical Engineering University of California, Santa Barbara Spring Exercise 3. Due: Thursday, 5/3/12

Department of Chemical Engineering University of California, Santa Barbara Spring Exercise 3. Due: Thursday, 5/3/12 Department of Chemical Engineering ChE 210D University of California, Santa Barbara Spring 2012 Exercise 3 Due: Thursday, 5/3/12 Objective: To learn how to write & compile Fortran libraries for Python,

More information

Lecture 20: Modes in a crystal and continuum

Lecture 20: Modes in a crystal and continuum Physics 16a, Caltech 11 December, 218 The material in this lecture (which we had no time for) will NOT be on the Final exam. Lecture 2: Modes in a crystal and continuum The vibrational modes of the periodic

More information

Formula for the inverse matrix. Cramer s rule. Review: 3 3 determinants can be computed expanding by any row or column

Formula for the inverse matrix. Cramer s rule. Review: 3 3 determinants can be computed expanding by any row or column Math 20F Linear Algebra Lecture 18 1 Determinants, n n Review: The 3 3 case Slide 1 Determinants n n (Expansions by rows and columns Relation with Gauss elimination matrices: Properties) Formula for the

More information

Hands-on Workshop: First-principles simulations of molecules and materials: Berlin, July 13 - July 23, 2015

Hands-on Workshop: First-principles simulations of molecules and materials: Berlin, July 13 - July 23, 2015 Hands-on Workshop: First-principles simulations of molecules and materials: Berlin, July 13 - July 23, 2015 R L e y E N e x Tutorial IV: Phonons, Lattice Expansion, and Band-gap Renormalization Manuscript

More information

PHYSICS 219 Homework 2 Due in class, Wednesday May 3. Makeup lectures on Friday May 12 and 19, usual time. Location will be ISB 231 or 235.

PHYSICS 219 Homework 2 Due in class, Wednesday May 3. Makeup lectures on Friday May 12 and 19, usual time. Location will be ISB 231 or 235. PHYSICS 219 Homework 2 Due in class, Wednesday May 3 Note: Makeup lectures on Friday May 12 and 19, usual time. Location will be ISB 231 or 235. No lecture: May 8 (I m away at a meeting) and May 29 (holiday).

More information

Linear Algebra Solutions 1

Linear Algebra Solutions 1 Math Camp 1 Do the following: Linear Algebra Solutions 1 1. Let A = and B = 3 8 5 A B = 3 5 9 A + B = 9 11 14 4 AB = 69 3 16 BA = 1 4 ( 1 3. Let v = and u = 5 uv = 13 u v = 13 v u = 13 Math Camp 1 ( 7

More information

General Physical Chemistry I

General Physical Chemistry I General Physical Chemistry I Lecture 11 Aleksey Kocherzhenko March 12, 2015" Last time " W Entropy" Let be the number of microscopic configurations that correspond to the same macroscopic state" Ø Entropy

More information

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

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

More information

Complementary approaches to high T- high p crystal structure stability and melting!

Complementary approaches to high T- high p crystal structure stability and melting! Complementary approaches to high T- high p crystal structure stability and melting! Dario ALFÈ Department of Earth Sciences & Department of Physics and Astronomy, Thomas Young Centre@UCL & London Centre

More information