Jump to content

Talk:Modxp412ls

From ChemWiki

A very nice and well attempted report. Remember to be explicit about perhaps even minor details that could be important - why are there fluctuations in the g(r) for solid? Sometimes your explanation was very good but you forgot to make your conclusion - you'll use the 0.0025 timestep. Also be careful to check through for spelling and grammar. All in all though, really good effort! Mark: 80/100


Theory

Velocity Verlet Algorithm

Newton’s second law, F=ma, allows for the calculation of acceleration of each atom in the system from known values of the force exerted on it and atomic mass. Integration of the equations gives a trajectory that describes the position, velocity and acceleration of the atom with time. The velocity-Verlet algorithm is one of the ways that Newton’s second law may be integrated; it assumes the positions, velocities and accelerations can be approximated by applying a Taylor series expansion and outputs atomic positions, accelerations and velocities at the same instant of time t with very good precision.

The position of an atom i, at time t is denoted by xi(t) and the velocity of the atom at time t is vi(t). After time step t+δt, the position of the atom can be expressed by:

xi(t+δt)=xi(t)+dxi(t)dtδt+12!d2xi(t)dt2δt2+13!d3xi(t)dt3δt3+𝒪(δt4)(1)

A single timestep can be expressed as:

x(n+1)=xn+vnΔt+12an(Δt)2(2)

v(n+1)=vn+12(a(n+1)+an)Δt(3) Very nice, be careful with your equation formatting (parentheses)

Fig 1:Velocity Verlet calcuated positions compared to classically calculated positions

Classically, the motion of a harmonic oscillator is given by x(t)=Acos(ωt+ϕ). It can be seen from the position calculation comparisons(Fig 1) that the position values obtained through classical calculations and those obtained using the Velocity Verlet algorithm are in close agreement. This is because the algorithm is self-starting therefore minimising round-off errors. The maximum error of the Velocity Verlet algorithm in this simulation is 5.91×103. Notably, the errors change follows a near oscillatory form has 5 maximas in the time simulated.

Fig 2:Error against time and error fit to a quadratic

In equation (1), the error of the Verlet algorithm is represented as O(δt4). The error per iteration of the algorithm can therefore be represented by:

x(t0+δt))=O(δt4)

After 2 timesteps of δt, the Taylor expansion becomes:

x(t0+2δt)=2x(t0+δt)x(t0)+δt2x(t0+δt)+O(δt4)

In terms of error:

error(x(t0+2δt))=2error(x(t0+δt))+O(δt4)=3O(δt4)

Through induction, the error can be generalised to:

error(x(t0+nδt))=n(n+1)2O(δt4)

Considering the error in position between x(t) and x(t+T), where T=nδt:

error(x(t0+T))=(T22δt2+t2δt)𝒪(δt4)

Therefore, the cumulative error over a constant interval is given by:

error(x(t0+T))=O(Δt2)

Therefore, the maxima of the error of the Velocity-Verlet algorithm increases quadratically with δt and the graph of the maxima of error against time can be fit to a quadratic equation as shown in Fig 2. IThis is really good - well done!

The total energy of the oscillator can be calculated by: E=p22m+kx22, where p is the momentum. Sincem=1,k=1, the equation can be simplified to E=p2+x22. To calculate the total energy in terms of velocity,p=mv can be substituted to give E=(mv)2+x22. The plot of the total energy of the simulated system


Fig 3a: Energy vs Time at 0.01 timestep with error limits of 0.5% either side
Fig 3b: Energy vs Time at 0.02 timestep with error limits of 0.5% either side

In order to ensure that the total energy does not change by more than 1% over the course of the "simulation", the timestep need so to be around 0.2. It is important to monitor the total energy when modelling a physical system numerically to ensure that energy has been conserved, as expected in real systems. Tick, correct.

Atomic Forces

The Lennard Jones potential(LJ) approximates the potential energy of the interaction between a pair of uncharged atoms. It is mostly expressed in the 12/6 form:

ϕ(r)=4ε[σ12r12][σ6r6]

In this equation, ε is the potential well depth, σ is the distance at which the potential between the pair of particles is zero and r is the distance between the pair of particles.

For a single Lennard-Jones interaction, the potential energy is at zero when r0=σ. Since force is the negative derivative of potential energy, the relationship between force and the LJ potential can be expressed as:

Fi=dϕ(rN)dri

Assuming ε and σ are constant, the derivative of the Lennerad-jones can be expressed as:

dϕ(rN)dri=24ε[2(σ12ri13)+(σ6ri7)]

Therefore, when the potential energy is zero, r0 is substituted for σ in the equation.

dϕ(r)dr0=24ε[2(r012r013)+(r06r07)]


dϕ(r)dr0=24ε[1r02r0]


dϕ(r)dr0=24ε[1r0]

Tick.

Therefore, when the LJ potential is zero, the force can be expressed as:

F=24εr0

Tick.

The equilibrium is reached when the attractive and repulsive forces balance, therefore the force becomes zero. Equating this to the derivative of LJ, the equation becomes

24ε[2(σ12r13)+(σ6r7)]=0

Again, since ε is a constant, the equation can be divided by it on both sides to give

2(σ12r13)+(σ6r7)=0
2(σ6r6)+1=0

Therefore, the equilibrium separation is defined by:

req=26σ

Tick.

The LJ potential at req can be expressed as

ϕ(req)=4ε(σ12(26σ)12σ6(26σ)6)

Tick.

ϕ(req)=4ε(1412)

Finally, this can be rearranged for the well depeth, ε


ε=ϕ(req)

Tick.


Integrating the LJ potential gives

ϕ(r)dr=4σ6ε(5σ11r6)55r11

.

When σ=ε=1.0, the equation becomes

ϕ(r)dr=4(11r65)55r11

Since the LJ potential decays rapidly with the separation distance,r, the potential energy generated by atoms with r above a certain distance will be negligible. As this simulation will be modeled with an infinite number pair interactions, finding this cutoff distance can help avoid the need to calculate the potential energy for an infinite number of pair interactions. By trialing different lower limits for the LJ potential integral, a suitable cutoff distance can be found.

2σϕ(r)dr=66928160=2.48x102

2.5σϕ(r)dr=8.18x103

3σϕ(r)dr=320569743085=3.29x103

Tick.

Periodic Boundary Conditions

Since 1ml is equivalent to 1cm3 and at standard conditions (298K, 1atm), the density of water is 1g/cm3, the number of molecules in 1ml of water can be found by diving the mass(m) and Avogdro's number(NA) by the molecular weight of water (Mw).

mNAMw=1×6.02214×102318.01528=3.34×1022

Tick.

Therefore, the volume of 10,000 molecules of water can be calculated by

100003.34×1022=2.99×1019cm3

Tick. If an atom located at

(0.5,0.5,0.5)

is moved along the vector

(0.7,0.6,0.2)

, the resulting position is

(1.2,1.1,0.7)

. Applying the periodic boundary of

(0,0,0)

to

(1,1,1)

, the resulting position becomes

(0.2,0.1,0.7)

. Tick.

Reduced Units

The output form LAMMPS MD simulations are given in reduced units to generate dimensionless forms, allowing for better numerical analysis. The conversion of reduced units to real units is relatively simple; For example, considering the Lennard-Jones parameters for Argon, the Lennard-Jones cutoff is r*=3.2, and in real units is r=r*σ=3.2×3.4×10×1010=1.09nm. The well depth is ε=0.997kJmol1.

The reduced temperature of

T*=1.5

corresponds to the real value of

T=1.5×120K=180K

. Good, tick.

Equilibration

Creating the simulation box

In order to model the system, a simulation box must be constructed in LAAMPS. The simulation box will contain the repeating lattice that will be used to study the system. The folling command defines the distance between each lattice point to be 1.07722(reduced units) in all directions of the 3D simulation.

Lattice spacing in x,y,z = 1.07722 1.0722 1.0722

Since the system defined in the experiment is simple cubic, there will be 1 atom per unit cell. The density can therefore be calculated by:

ρ=1(1.07722)3)=0.7999940.8

The atoms coordinates were not randomly generated to eliminated the possibility of two atoms being generated too closely. If the positions of two atoms are too close, the two atoms may collide and the strong repulsive interactions bewteen the two centres will propel the atoms apart, leading to rapid increases in the potential energy of the system, causing the system to be energetically unstable, which is not an accurate representation of the systems under study. Good

In a face-cetered cubic system, there are four lattice points per unit cell. Therefore, if the previous system was modelled on a FCC lattice with a lattice point number density of 1.2, the lattice spacing would be 1.49 in reduced units.

Lattice spacing=41.23=1.49

If the 1000 unit cells were to be generated by the creat_atoms command, 4000 atoms would be generated for a FCC lattice. Tick


Mass 1 1.0

This indicates that the mass of the single type of atom in the simulation is 1.0. Tick

Pair_style lj/cut 3.0

"Pair_style" sets the interactions to pairwise interactions. "lj.cut" is the specific pair style used that will compute the standrad 12/6 Lennard-Jones potential with no Colombic interaction."3.0" indicates that the cutoff for all atoms will be at 3.0.Tick

Pair_coeff * *1.0 1.0

"Pair_coeff" specifies the pairwise force field coefficients, the functional form and parameters used to calculated the potential energy. the double asterisks indicate that the command will be applied to all atoms.Tick

Since both xi and vi are bith *typo being specified, the Velocity-Verlet algorithm will be used for the simulation. Tick

To simplify the LAMMPS code, the timestep variable should be attributed a value, i.e. 0.01, that can be called upon by using "${timestep}". This can be excuted by writing:

variable timestep equals 0.01

The advantage of defining the variable is that if the timestep were to be changed, rather than having to individually write the numerical timestep over and over again in the script, which may result in human errors especially if the script is long and complex, the timestep would only need to be altered once, at where the variable was first defined. Tick

Fig. 4a: Pressure vs Time at 0.01 timestep
Fig 4b: Temperature vs Time at 0.01 timestep
Fig 4c: Total energy vs Time at 0.01 timestep
Fig.5: Graph of densities obtained through molecular modelling and Ideal Gas Law

It can be seen from the Pressure/Time and Temperature/Time graphs that the system reaches equilibrium at 0.01 timestep as the average pressure and temperature values become constant. Analysis of the output temperature and pressure data from the simulation shows that equilibrium is reached at around t=0.18. The approximate average pressure and temperature after equilibration is 1.26 and 2.61 respectively (both in reduced units).Good, agreed

Since it is now known that the simulation reaches equilibrium at 0.01 timestep, longer timesteps can be trialed to find a more time efficient timestep. It is important to ensure that the timestep chosen for later experiments will also afford accurate results therefore simulations were ran at 4 further timesteps (0.0025, 0.0075, 0.01 and 0.15) and the total energy output from them were compared with that of the 0.01 timestep. It can be seen from Fig 5 that the total energy outputs from 0.0025 timestep are in very close agreement with those produced from 0.01 timestep. Systems simulated with 0.0075 and 0.01 both reach equilibrium but the output total energy values are slightly higher than those produced at the slowest timestep, 0.001, thus rendering them inaccurate. Therefore, the largest timestep that can be used to produce acceptable results is 0.025.The worst timestep to use would be 0.015 because the system does not reach equilibrium in the time simulated as indicated by the positive incline in total energy against time shown in Fig.5. Tick, what are you going to use and why?

Running simulations under specific conditions

The velocity Verlet algorithm allows for the observation of systems that preserve total energy(E), volume(V) and the number of atoms(N), also known as the NVE ensemble. In order to investigate molecular dynamics with different experimental conditions, the systems can be set up with different parameters to mimic those conditions. In this section, systems will be subject to the constant-pressure, constant temperature(NpT) and the constant volume ensemble.

Barostat and Thermostat

The energy of a molecule with N atoms, each with 3 degrees of freedom can be expressed as:

EK=32NkBT (4)


12imivi2=32NkBT (5)


The temperature will fluctuate after each timestep therefore a velocity-scaling constant, γ, is introduced to keep the system isothermal.

12imi(γvi)2=32NkB𝔗 (6)

To solve for γ, firstly, sum (5) and (6) to give

12imivi2+12imi(γvi)2=32NkBT+32NkB𝔗

Since γ is a constant, it can be taken out of the summation and the equation can be rearranged to

12imivi2(1+γ2)=32NkB(T+𝔗)

Considering the relationship shown in eqn (5), the equation above can be rearranged to

32NkBT(1+γ2)=32NkB(T+𝔗)


T(1+γ2)=T+𝔗


γ2=𝔗T


γ=𝔗T Tick

However, this is not the best method as rescaling at each step causes discontinuities in the momentum part of the phase space trajectory[1].

Examining the Input Script

 fix aves all ave/time 100 1000 100000 v_dens v_temp v_press v_dens2 v_temp2 v_press_2

the command "fix aves" applies the average operation to the systems. "ave/time 100 1000 100000" computes the global time-averages of the variables inputted(density, pressure and temperature). "100 1000 100000" specify the timesteps the input values will be used in order to contribute to the average. Therefore for this simulation, the final average will be calculated using values at timestep 100, 200, 300....100000. In total, 1000 values will be used to calculate the global average.

run 100000

This command tells LAMMPS to run the simulation over 100,000 timesteps. Since a timestep of 0.0025 will be used, 250 time units simulated. Why do you use variables?

Plotting the Equations of State

Fig.6:Density vs Time Graph at p=2.4 and p=2.6

The NpT ensemble (also known as the isothermal-isobaric ensemble) describes systems with a fixed number of particles, N, in contact with a thermostat at temperature T and a bariostat *typo at pressure p. The system exchanges heat with the thermostat and pressure with the bariostat *barostat . Therefore, the total energy,E, and volume, V, both fluctuate at thermal equilibrium. Simulations were conducted at two pressures (2.4, 2.6 in reduced units), and at 5 temperatures(2, 2.5, 3, 3.5, 5). In order to compare the results obtained through the Lennard Jones simulations to theoretical Idea Gas Law (PV=NkBT) results, a plot of density and temperature was constructed at both pressures(Fig.6). Good

In plot of density against temperature (Fig.6), the error bars of the data generated do not overlap, indicating that the density outputs from the simulations are statistically significant, thus analysis of the graphs can be carried out with confidence.

The graph shows density decreases with increasing temperature. This is an expected phenomenon as the system will increase in volume to compensate for the increase in kinetic energy due to increase in temperature. The Ideal Gas Law can be rearranged to show the inverse relationship between temperature and density.

NV=PkBT (7)


Fig.7: Graph of densities obtained through molecular modelling and Ideal Gas Law

Additionally, Fig.6 also shows that at constant temperature, density increases with increasing pressure. This is again expected because if increasing pressure was applied to a container with fixed number of particles, the volume would decrease, hence decreasing the density of the system. Again, this relationship can be justified by (7), where NV is directly proportional to P.


It can be seen from Fig.7 that the densities obtained through the Lennard-Jones molecular modelling is significantly lower than the densities obtained through Ideal Gas Law calculations. This is expected as the Ideal Gas Law assumes that molecules do not interact with each other, thus there will be no repulsion factor as there is in the LJ model, thus making the particles in the Ideal Gas system to be more compressible. This means that the molecules occupy negligible volume therefore for a given volume, the density will be higher. In the LJ model, the particles interact and repulsion occurs when r is small, hence the density at a given volume will be lower. Tick

The Ideal Gas Law is most accurate in describing small gases at low pressure and low temperature

As seen from Fig.7, the largest discrepancies between the LJ simulation densities and the Ideal Gas densities occur at low temperature and high pressures(the gradient of Ideal Gas curve is higher at pressures whilst the gradient of the LJ simulation curve results do not differ as visibly). This is because the system behaves more like an ideal gas at high temperature and low pressure. The reason for this observation is that intermolecular interactions become less limiting when the thermal kinetic energy of the system is high i.e. high temperature; At lower pressure, assuming the volume is large, the intermolecular distance becomes larger therefore the density is less affected by the separation, r. Tick, very good

In conclusion, discrepancies increase with an increase in pressure and a decrease in temperature.

Heat Capacity Calculation

The NVT(canonical) ensemble describes systems have a fixed number of particles, N, and volume, V, that are in contact with a thermostat at temperature T. In this section, the heat capacities under the NVT ensemble were calculated for two different pressures (p=0.2 and p=0.8) and at five different temperatures each (T=2, 2.2, 2.4, 2.6, 2.8) by using the equation

CV=ET=Var[E]kBT2=N2E2E2kBT2(8)

To run the simulation under NVT conditions, the following code was used.

### DEFINE SIMULATION BOX GEOMETRY ###
variable dens equal 0.2
variable T equal 2.0
variable timestep equal 0.0025

lattice sc ${dens}
region box block 0 15 0 15 0 15
create_box 1 box
create_atoms 1 box

### DEFINE PHYSICAL PROPERTIES OF ATOMS ###
mass 1 1.0
pair_style lj/cut/opt 3.0
pair_coeff 1 1 1.0 1.0
neighbor 2.0 bin

### ASSIGN ATOMIC VELOCITIES ###
velocity all create ${T} 12345 dist gaussian rot yes mom yes

### SPECIFY ENSEMBLE ###
timestep ${timestep}
fix nve all nve

### THERMODYNAMIC OUTPUT CONTROL ###
thermo_style custom time etotal temp press
thermo 10

### RECORD TRAJECTORY ###
dump traj all custom 1000 output-1 id x y z

### SPECIFY TIMESTEP ###

### RUN SIMULATION TO MELT CRYSTAL ###
run 10000
unfix nve
reset_timestep 0

### BRING SYSTEM TO REQUIRED STATE ###
variable tdamp equal ${timestep}*100
variable pdamp equal ${timestep}*1000
fix nvt all nvt temp ${T} ${T} ${tdamp} 
run 100000
reset_timestep 0

### MEASURE SYSTEM STATE ###
thermo_style custom step etotal temp vol atoms
variable temp equal temp
variable temp2 equal temp*temps
variable energy equal etotal
variable energy2 equal etotal*etotal
variable atoms2 equal atoms*atoms
variable volume equal vol
fix aves all ave/time 100 1000 100000 v_temp v_temp2 v_energy v_energy2 v_volume
unfix nvt
fix nve all nve
run 100000

variable avetemp equal f_aves[1]
variable aveheatcap equal ${atoms2}*(f_aves[4]-(f_aves[3])(f_aves[3])f_aves[2]
variable avevolume equal f_aves[5]
variable aveheatcapv equal ${aveheatcap}/${avevolume}

print "Averages"
print "--------"
print "Temperature: ${avetemp}"
print "Total energy: ${etotal}"
print "Volume: ${avevolume}"
print "Heat Capacity: ${aveheatcap}"
print "Heat Capacity over V: ${aveheatcapv}"

The simulation box was defined with parameters of 15×15×15 which resulted in a total of 3375 atoms. The volume for p=0.2 was and for p=0.8 was

In order to compare how heat capacities vary at different volumes, the heat capacity must be divided by the volume of each system thus CVV was plotted against temperature for each system (Fig.8).

Fig.8: Cv/V against temperature for densities p=0.2 and p=0.8

The specific heat capacity defines how much heat is needed to raise the temperature of a unit mass by a unit degree of temperature. Fig.8 shows that the heat capacity has an inversely proportional relationship with temperature (so why the linear plot? ), in agreement with the definition of equation (8). This can be explained by the band-gap (density of states ) between the lattice energy levels decreasing with increasing temperature. Therefore, less energy is required to heat the system; relating this back to equation (8), where it is shown that Cv is directly proportional to energy, increasing the temperature will decrease the heat capacity.

The results also show that heat capacity decreases with decreasing density. This is expected as high density leads to lower volume for a fixed number of atoms so it its expected that the heat required to raise the temperature of the system will be lower as particles are closer together compared to a lower density system with the same number of atoms where the volume is larger.Tick

Structural properties and the radial distribution function

The radial distribution function, g(r), describes the probability of finding a nearest neighbour from a reference particle. Thus it allows for the identification of the phase of the system as it provides information about the variation of density from a central reference particle. Tick

Fig 9 g(r) against distance for solid, liquid and gaseous phases

The radial distribution function was plotted for solid, liquid and gas for a Lennard-Jones material(Fig.9).The parameters were chosen from the Lennard-Jones phase diagram reported by Hansen and Verlet[2]..

Phase Density Temperature
Solid 1.2 1.0
Liquid 0.8 1.2
Vapour 0.1 1.6

In all phases, a common factor was that g(r)=0 until r=0.9(reduced units). This is because at distances shorter than atomic diameter, strong repulsive forces causes the g(r) to be zero. Tick

The qualitative appearance for the three systems have clear differences. The solid system has the most number of peaks followed by liquid then vapour. This appearance is due to the fact that the peaks indicate the density around each reference atom therefore, the phase with the most regular structure,solids, will have the most discrete peaks. The solid peaks show a general decrease in amplitude as the r increases with some fluctuations (Why does it fluctuate?). The first three peaks in the solid RDF represent the first three coordination shells of the solid; the first peak represents the nearest neighbour of the reference molecule, the second peak is the second nearest neighbour and the third peak is the third nearest neighbour. There is zero probability of finding a particle in regions between the peaks as molecules in a solid cannot move. The distance between the zero probability minima gives the lattice spacing therefore the lattice spacing is defined by the second nearest neighbour; it is approximately 1.49 in reduced units. The appearance of the peaks in the solid system also indicate that the solid phase has long and short range order; the three tall peaks indicate short range order while the fluctuating smaller peaks indicate long range order.

The liquid g(r)has three peaks which decrease in amplitude with increased interatomic distance. The peaks are less narrow that those in the solid phase thus suggesting the system to have more disorder. The amplitude of the peaks decrease with separation, showing order decreases with separation due to the random Brownian motion of of particles. The low number of peaks in the radial distribution function suggests that there is only short range order in the system, specifically between the first three neighbouring atoms.

For gases, a single broad peak is observed at around r=1. The broad peak suggests that there is high disorder in the gaseous phase thus there is no short nor long range order. Tick

Fig.10: Expansion of the integral of g(r) for solid phase

Plotting the integral of the RDF against distance will give information about the coordination numbers of the neighbours of the reference particle in a solid. The inflection points called out in the Fig.10 show the coordination number of the three nearest neighbours of the reference particle. Since the solid system was modeled on a FCC lattice, the reference particle is expected to have 12 nearest neighbours (this is confirmed by the point at r=1.225). The next inflection point at r=1.625 has a g(r) integral of 18. Since the plot is a running integral of g(r), the coordination number of the second nearest neighbours is 1812=6. Thus, the coordination number of the third nearest neighbours is 4218=24.Tick, nice

Dynamical properties and the diffusion coefficient

Mean Squared Displacement

The mean squared displacement measures the average distance a particle travels in a given time from a reference position, due to random motion. It is defined: MSD(xx0)2=1Nn=1N(xn(t)xn(0))2

In this equation, xn(t)xn(0) represents the vector distance traveled by a particle n over time interval of t. The square of the displacement is then averaged over N particles by summing n from 1 to N and then dividing by N.

Smaller system simulation(3375 atoms) Larger system simulation(1 million atoms)
Fig.11a:Solid Simulation at d=01.2, T=1.0
Fig.11b:Solid Simulation at d=0.8, T=1.2
Fig.12a:Liquid Simulation at d=0.8, T=1.2
Fig.12bLiquid Simulation at d=0.8, T=1.2
Fig.13a:Vapour Simulation at d=0.1, T=1.6
Fig.13b:Vapour Simulation at d=0.1, T=1.6

The plots generated are shown above. In a solid system, the particles are bound to their position so there is not sufficient kinetic energy to reach a diffusive behaviour and this is shown in Fig.11a, as indicated by the nearly constant value of the MSD after around timestep 200.

The liquid plot(Fig.12) shows a clear linear relationship (R2=0.9999) between MSD and time. This shows that the particles in the system move acccording to Brownian motion.

Fig.14:Vapour Simulation at d=0.1, T=1.6 for smaller system at timesteps above 2000

In the plot for the gaseous phase(Fig.13), relationship between MSD and time is initially curved, followed by a near linear relationship(shown by Fig.14 when only consdiering the relationship between MSD and time above timestep 2000). The inital curvation is due to the fact that atoms are placed randomly to simulate the system. Since it is a gaseous system, the interatomic separations are high. This results in a lower frequency of collisions thus the overall velocity the atoms travel at appears to be constant. Therefore, by definition, the distance travelled per unit time is also constant, hence MSD is proportional to t2. As more time is simulated, more collisions occur and the atomic motion becomes more consistent with Brownian motion thus the MSD/Time graph tends to linearity. Takes a while for the system to act like a random walk

The simulations performed at 3375 atoms and a million atoms both generated MSD/Time graphs that show the same general trends for each phase. In the solid simulations, there is less fluctuations in the MSD of the larger system, suggesting the system to be more stable for solids. The difference in the output values of simulation performed on 3375 atoms and the 1 million atoms are relatively small(around 0.02 difference in MSD). Since the phase parameters used for the larger simulation were not stated, the discrepancy could also be caused by the different simulation conditions used. However, this discrepancy could also be due to the difference in number of atoms used; if this were the case, it can concluded that there is no need to use such large systems as the difference in output data is not significantly difference thus the tradeoff for longer simulation times is not worthwhile. Tick

Einstein showed that the the self-diffusion coefficient is related to the mean-squared displacement:

D=16δr2δt

Substituting simulation values for the 3375 atoms system, the diffusion coefficients in reduced units are

Gas:D=16×0.02260.002=1.88 Solid: D=5.00×105 Liquid:D=8.33×102

For the larger 1 million atoms system

Gas:D=16×0.03260.002=3.03 Solid: D=4.17×107 Liquid:D=8.33×102

The diffusion coefficients are very similar for the smaller and larger model.Tick

Velocity Autocorrelation Function

The motion of a 1D harmonic oscillator is given by

x(t)=Acos(ωt+ϕ)

Velocity is the first derivative of positions and time:

v(t)=drdt

Therefore, the position of a 1D harmonic oscillator at a specific velocity can then be found by substituting

v(t)=d(Acos(ωt+ϕ)dt
v(t)=Aωsin(ωt+ϕ)

At timestep t+\tau , the velocity will therefore be:

v(t+τ)=Aωsin(ω(t+τ)+ϕ)

Substituting this into the velocity correlation function,

C(τ)=Aωsin(ωt+ϕ)Aωsin(ω(t+τ)+ϕ)dt(Aωsin(ωt+ϕ))2dt


C(τ)=sin(ωt+ϕ)sin(ω(t+τ)+ϕ)dtsin2(ωt+ϕ)dt

Considering the trigonometric identity sin(x+y)=sin(x)cos(y)+cos(x)sin(y). The equation can therefore be written as:

C(τ)=sin(ωt+ϕ)[sin(ωt+ϕ)cos(ωτ)+cos(ωt+ϕ)sin(ωτ)]dtsin2(ωt+ϕ)dt

Since ω and τ are both constants, they can be taken out of the integral:

C(τ)=cos(ωτ)sin2(ωt+ϕ)sin2(ωt+ϕ)dt+sin(ωτ)sin(ωt+ϕ)cos(ωt+ϕ)dtsin2(ωt+ϕ)dt=cos(ωτ)+sin(ωτ)sin(ωt+ϕ)cos(ωt+ϕ)dtsin2(ωt+ϕ)dt

Since sin(x) is an odd function, evaluating its integral by limits that are symmetric across the origin, to , will be zero. Thus the right hand side of the equation will equal zero and the equation becomes:

C(τ)=cos(ωτ)

Good


Fig.15: Graph of VACF for solid, liquid and the Simple Harmonic Oscillator

A graph of VACF for the Lennard Jones liquid and solid simulations was plotted along with the VACF graph of the Simple Harmonic Oscillator. It can be observed in the graph that there is a maximum difference between the ν(t) and ν(t+τ) at the minima of the solid and liquid plots. In the solid,, this indicates that atoms have collided and are changing directions of motion. In the liquid, this phenomena can be attributed to the atom colliding with their "solvent cage" and then changing direction. The minima of the solid is lower than the minima of the liquid as there are stronger interatomic forces in the solid. Tick, nice description

The liquid VACF has one weak oscillation as the particles in the system only interact with their closest neighbours whereas in the solid, a series of oscillations are seen as the ordered lattice allows atoms to vibrate forwards and backwards. However, the amplitude of the oscillations become smaller.

For the Simple Harmonic Oscialltor, the appearance of the VACF is very different. This is due to the fact that the oscillator does not consider the interactions with other atoms in the system, and instead models a system with no energy loss, thus the velociy never decreases.

To find the running integral of under the VACF graphs, the trapezium rule was employed as the diffusion coefficient can also be defined as

D=130dτv(0)v(τ)

The last point of data on the running integral of VACF graphs gives the total integral of the VACF graphs.

For the smaller system the results are as follows

Fig.16a:Running intergral of VACF against time for Gas in small system
Fig.16b:Running intergral of VACF against time for Liquid in small system

Solid:D=4.63×104

Liquid:D=7.93×102

Gas:D=2.35 Tick

Fig.18a:Running intergral of VACF against time for Gas in large system
Fig.18b:Running intergral of VACF against time for Liquid in large system

For larger system, the diffusion coefficients are

Solid:D=5.67×105

Liquid:D=7.93×102

Gas:D=2.35

There is little discrepancy with the diffusion coefficients obtained from the larger and smaller system.

The coefficients calculated from the VACF method show the same trend as the Mean Displacement Squared approach. The diffusion coefficient was largest for gases, then liquids and smallest for solids. Neither methods were particularly affected by the sample size of the simulation box. The two methods produced D of similar values and of similar magnitudes for the liquid and gas simulations but the coefficients from the VACF method were larger significantly larger than those obatined thorugh the MSD method. Therefore, it must be noted that using the trapezium rule to integrate the VACF is likely to accumulate errors over time, especially for solids as solid VACF curves are non periodic. The accuracy of the method could be increased by using smaller timesteps but this would have implications on the simulation time. Another way to refne the VACF method would be to use a more sophisticated integration method. Good comparison

References

  1. http://home.gwu.edu/~yxzhao/ResearchNotes/ResearchNote007Thermostat.pdf
  2. http://journals.aps.org/pr/abstract/10.1103/PhysRev.184.151