Talk:LiquidSimulationsSL7514
General comments: Very detailed and expansive. Ensure that extension doesn't get in the way of good physics. Think simple and expand but good report. 87/100
Introduction to Molecular Dynamics Simulations
TASK 1

TASK 2

TASK 3
The total energy of a simple harmonic oscillator is given by:
Couple of deductions can be made from Figure 1 and 2. Firstly, the total energy of the system oscillated over the timestep, and the amplitude of the oscillation was more severe when the timestep was larger. When the total energy was equal to 0.5, less than 1% deviation would mean that the total energy must fall within the range 0.5±0.005. As it can be seen from Figure 1, the total energy did not deviate beyond 0.495 when the timestep was set to 0.2. When the position of the particle was either 1 or -1, no deviation in total energy from 0.5 was observed whereas the deviation was greatest when the position of the particle was at 0 or when the velocity of the particle was maximum. The main approximation in velocity-Verlet algorithm was that Taylor expansion of the velocity by half a step was taken. Tick
Since the expansion was only performed up to the first order term (corresponding to acceleration), the validity of the approximated velocity would be low for large timesteps. Don't think of this as an expansion: the expansion of the Velocity-Verlet comes in the Taylor expansion of x(t + δτ). In order to calculate the new velocity, we take the original velocity and add the velocity change over an average of the change in velocity with time (acceleration). True, this would become increasingly worse for larger timesteps because we would need to numerically calculate the integral Therefore, larger the velocity of the particle, greater the error and hence the maximum from the error plot were observed when the displacement of the particle corresponded to 0. The errors were small at positions corresponding to 1 and -1 because the error in velocity was small as the velocity was close to zero. Since the position was calculated using this calculated velocity, this corresponded to smaller error in position. It should also be noted that the maximum error increased after each cycle due to the propagation in error. If the velocity was calculated incorrectly in the previous cycle, this value was not ignored in the subsequent cycle and hence the error accumulated in the algorithm.
Newtons equations strictly conserve the total energy of the system and hence this should ideally be preserved in the numerical solutions. Monitoring the total energy of the system is important to ensure that the timestep chosen in the simulation is sensible.Tick, but not just timestep - whether fundamentally the system has equilibrated It crucial to remember that in velocity-Verlet algorithm, the simulation has been discretised and hence for large timesteps the Taylor expansion would be inaccurate as only limited number of terms are considered. If the previous configuration is inaccurate, the subsequent coordinates of the atoms or molecules are even more unrealistic and so the energy may not converge to a value but diverge. Unlike the Monte Carlo method, no configurations are ignored in Molecular Dynamics (MD) and the divergence may arise due to the accumulation of error.

TASK 4
At , the potential energy must be zero:
Tick
The derivative of the Lennard Jones potential is given by:
and since the force is given by:
when , the force is given by:
Tick
At the equilibrium, the gradient of the potential must equal zero
Tick
The well depth is given by:
Tick
The following integrals were evaluated:
Tick
Tick
Tick
The evaluation of the integrals showed that the potential beyond separation of atoms was negligible. In LAMMPS simulations, the potential for each atom was defined within the cutoff distance and hence there were no interaction between atoms with separation greater than this value.
where is the cutoff distance.Tick
TASK 5
The number of molecules in 1 ml of water was calculated in standard conditions as below. The density of water at standard conditions is one, and hence the number of moles of water in 1 ml is given by:
Tick
To find the volume of 10000 water molecules at standard conditions, the number of moles of water was calculated first.
Since the density of water is 1 g/ml, the volume is
Tick
TASK 6
When the atom moves from by , the new position is given by:
Tick
to take the periodic boundary condition (PBC) into account, whenever the position vector exceeds the unit cell length , this should be subtracted
Tick
TASK 7
To find the cutoff distance in real units:
Tick
The well depth is given as follows in real units:
Tick
The temperature in real units is given by:
Tick
Equilibration
Task 1
In LAMMPS, for default atom_style command all atoms are considered as point particles [1] hence there was no overlap between between the atoms. However, when the initial positions of the particles are generated randomly, there is a probability that two atoms will have locations very close to each other. As r → 0, the potential increases to infinity according to . Therefore, the gradient and hence the force on the atoms will be very large and the particles will have a large velocity. Unless the timestep is sufficiently small to model the behaviour, the simulation will output an error. In general, Lennard-Jones potential is considered as a hard-core model due to the steepness of the repulsive term and the atoms rarely approach distances less than . This has many important implications to the behaviour of the system and will be explored further in the later section. Tick, correct
Task 2
For a simple cubic lattice, the number of lattice points in a unit cell is one, therefore the density is given by:
Tick, correct
where N is the number of lattice points and L is the length of the cubic unit cell ( is the volume of the unit cell).
For fcc lattice, the number of lattice points in the unit cell is 4 and hence for the density of 1.2
L = (N/D}^(1/3} so your equation is wrong, your calculation is correct...
Task 3
Each unit cell contained 4 more atoms in fcc than sc, so in the fcc lattice 4000 atoms will be created Tick, correct
Task 4
For unit style lj, all quantities are unitless [2]
mass 1 1.0
- This command sets the mass for all atoms of type 1 to 1.0 in reduced units [3]
pair_style lj/cut 3.0
- This command computes the standard 12/6 LJ potential between atoms using the equation as defined in the previous section. 3.0 is the cutoff distance corresponding to in reduced units [4]
pair_coeff * * 1.0 1.0
- This command specifies the LJ potential parameters. The command * means all atom types from 1 to N and hence is used to set the coefficient for multiple pairs of atoms (but in this simulation only one atom type was considered). The following two numbers 1.0 and 1.0 correspond to (energy reduced units) and (distance reduced units) in this order. [5] Tick
Task 5
The velocity-Verlet algorithm is implemented. For Verlet algorithm, the initial position and position of atoms one previous timestep is required. Tick
Task 6
timestep 0.001 run 100000
Setting the timestep and run values to a variable rather than quoting them as shown above has an advantage in input file editing. For instance, if the input file needs to command LAMMPS to run several simulations of equal run length, and there is a need to change the run length from 100000 to 50000, it would be easier simply to change the value within the variable instead of going through the input file and change the run values one by one. Tick but most important here is changing the timestep
Task 7
The system has reached equilibrium as the energy converges to a value. From Figures 4, 5 and 6 above, it is clear that the system reach equilibrium after 0.5 time in reduced units. The fluctuations were observed for energy, temperature and pressure but it was greatest for the pressure. The mean squared fluctuation in temperature is given by [6]:
Therefore, the fluctuation is proportional to and so decreases according to . Figure 7 shows the temperature plot for the equilibration where the system size was increased by a factor of ten. It can be clearly observed that the fluctuations in the system is much smaller as predicted by the relationship above.

Figure 8 shows the energy plot for the system equilibrated using five different timesteps. Timestep of 0.015 would be particularly a bad choice as the total energy of the system fail to converge to a value. The divergence was due to the error occurring in the integration leading to unstable configurations as discussed in the previous section. For timesteps 0.0075 and 0.01, the system has converged to a wrong energy value. For the timesteps 0.001 and 0.0025, there was no observable difference in the converged energy value meaning that decreasing the timestep beyond 0.0025 is unlikely to have a significant effect on the simulation. In order to optimise the computational time, 0.0025 was the timestep chosen for the subsequent simulations. This is a very approximate approach to choosing the optimum timestep and literature search showed that there are mathematical proof available to what is the best timestep to use as shown by Choe et al. [7] Tick
Running Simulations Under Specific Conditions
Task 1
The kinetic energy of the system without the correction is given by:
The kinetic energy of the system with the correction is given by:
Sub into
Tick
Task 2
Numbers 100, 1000 and 100000 corresponds to Nevery, Nrepeat and Nfreq from the LAMMPS manual and controls which timesteps will be used to calculate the average.[8]. Nevery specifies the timestep interval, Nrepeat specify how may times to repeat the collection from the end, and Nfreq specifies how often the average will be printed. This setting would therefore take samples every 100 timestep for one thousand times and will generate one average at the end of the simulation as Nfreq = total timestep = 100000. Nevery * Nrepeat must always less or equal to Nfreq. Tick
Task 3
Figure 9 and Figure 10 shows the variation in density as for the temperature range 1.6 to 2.4. The error bar in x-direction was too small to be observed directly on the plot. In order to include the ideal gas relations in the plot, the equation must be converted to reduced units. Pressure has same units as energy over volume.
Sub in the following relations into the ideal gas equation
For the pair potential describing the interactions in simple liquids, the most important feature is the repulsions. Unlike gas, the interatomic separation in liquids are much smaller and hence the short-range repulsions characterises the liquid state. The attractive forces are long range and vary little with the distance forming a uniform background. The attractive interactions has a little role in determining the properties of the liquid state. [9] Since the simulation was performed in the supercritical fluid region, it was expected that the repulsive interactions had more significant role than in the gaseous state. In the ideal gas model, there are no interactions between the particles and hence they would exist with smaller interatomic distances compared to the LJ supercritical fluid. This was the reasoning behind why the resulting density from LAMMPS simulation was lower than the ideal gas prediction for the entire temperature range tested.Tick
Figure 9 showed as the temperature increased, the density of the system decreased for both pressures at 2.5 and 3.5. This observation was due to the thermal expansion of the system; at higher temperatures the average kinetic energy of the system increasing as according to the equipartition equation derived in the previous section. Therefore the velocity of the particles increases which in turn increases the repulsive interactions between the atoms. Hence, the particles exists with greater interatomic separation compared to the lower temperature simulations and so the simulation box size increased in the NPT ensemble. It should also be noted that the agreement between the ideal gas and LAMMPS simulation results were better as the temperature increased. Due to this decrease in density at higher temperatures, the behaviour of the LAMMPS system was more ideal-gas like meaning the repulsive interaction had a less significant role. Similar reasoning would also explain why at lower pressure, the agreement between ideal gas and LAMMPS simulation was better (the difference between the dashed line and the solid line in Figure 10). At lower pressures, the interatomic separation increases and again the system became more ideal gas like.Tick
Extension 1
In this section, the pressure dependence of the system was investigated to justify the difference in repulsive and attractive interactions as presented in the previous section. The NPT equilibration was performed in the pressure range 0.1-1.5 reduced units and the corresponding density was calculated. Temperature remained constant at 2.0 for all simulations to ensure there were no phase transition. The LAMMPS simulation results were than compared to the ideal gas plot using the reduced ideal gas equation derived above.

The result in Figure 11 can be divided into three regions; at very low pressures, the agreement between the ideal gas plot and the LAMMPS simulation results converged. In the pressure range 0.3-0.6, the LAMMPS simulation results showed greater density than it was predicted by the ideal gas equation, and finally at very high pressures, the LAMMPS simulation showed much lower density as according to TASK 3. At very low pressures, the system size was very large and hence most particles existed with the interatomic distances greater than the LJ cutoff specified in the LAMMPS simulation. Therefore, the interatomic interactions were minimal and the ideal gas was a good model to use. At the intermediate pressure range, the system size was small enough such that the interatomic forces became significant. However, since the attractive interaction has much longer range than the repulsive, the attractive forces dominated and hence, the LAMMPS simulation resulted in higher density than the ideal gas prediction. At higher pressures, the system size was sufficiently small for the repulsive interaction to take its effect and hence the density predicted by LAMMPS was lower than the ideal gas equation. Good
Calculating Heat Capacities Using Statistical Physics
The LAMMPS input script used to perform heat capacity measurements using NVE ensemble is shown below
### DEFINE SIMULATION BOX GEOMETRY ### variable D equal 0.2 lattice sc ${D} 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 ### SPECIFY THE REQUIRED THERMODYNAMIC STATE ### variable T equal 2.0 variable p equal 2.5 variable timestep equal 0.0025 ### 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} # system simulated in nvt with a specific density run 10000 unfix nvt fix nve all nve reset_timestep 0 ### MEASURE SYSTEM STATE ### thermo_style custom step etotal temp press density atoms variable dens equal density variable dens2 equal density*density variable temp equal temp variable temp2 equal temp*temp variable press equal press variable press2 equal press*press variable energy equal etotal variable energy2 equal etotal*etotal variable no_atoms2 equal atoms*atoms fix aves all ave/time 50 2000 100000 v_dens v_temp v_press v_dens2 v_temp2 v_press2 v_energy v_energy2 run 100000 variable avedens equal f_aves[1] variable avetemp equal f_aves[2] variable avepress equal f_aves[3] variable errdens equal sqrt(f_aves[4]-f_aves[1]*f_aves[1]) variable errtemp equal sqrt(f_aves[5]-f_aves[2]*f_aves[2]) variable errpress equal sqrt(f_aves[6]-f_aves[3]*f_aves[3]) variable heatcap equal ${no_atoms2}*((f_aves[8]-(f_aves[7]*f_aves[7]))/f_aves[5]) print "Averages" print "--------" print "Density: ${avedens}" print "Stderr: ${errdens}" print "Temperature: ${avetemp}" print "Stderr: ${errtemp}" print "Pressure: ${avepress}" print "Stderr: ${errpress}" print "heatcap: ${heatcap}"

The observed heat capacities were to the order of . Small heat capacity was expected as the measurements were performed in the NVE ensemble meaning the energy of the system was held constant and the fluctuations were very small. The heat capacity of the system decreased as the temperature increased for both pressure systems. The literature search showed that the reasoning behind this behaviour came from liquid potential-energy landscape with intervalley motion considerations.[10] [11] [12] [13]. The heat capacity at constant volume is given by:
so in order to explain the behaviour, the change in the internal energy as a function of the temperature need to be considered. Consider the motion of one atom as a probe with all the other atoms fixed in space. To visualise the potential energy surface, the potential can be plotted vertically against the volume on the horizontal plane. Valleys and ridges will exist on the plane as the potential will be higher at the positions occupied by the atoms and the potential will be lower in open spaces (for liquids, the surface will not be regular compared to the solid). The mean potential for the probe ion can be considered as the average potential across the region which is reachable. At lower temperatures, there is insufficient energy in the system and hence the probe atom is restricted to the valleys. At higher temperatures, the probe can move freely over the entire potential energy surface. Therefore, the average potential for the probe will initially increase with the temperature but will eventually saturate at higher temperature range when the entire surface become reachable. Figure 13 illustrates this change in the mean potential per probe atom as a function of temperature. The literature showed that this limit corresponded to per atom. [10]

Since the heat capacity is given by the gradient of the potential, the reasoning above explains the decrease in heat capacity as the system cannot store additional thermal energy.
To explain the decrease in heat capacity the with density, the density of state (DOS) needs to be considered. DOS is given by
where n is the number of states and E is the energy.[14] DOS therefore reflects the number of states per given energy level interval. Since the number atoms per unit volume decreased with the decreasing density, the number of energy levels available per unit energy has also decreased. Hence, the increase in density has increased the DOS and the heat capacity increased as the system was able to store more energy. Tick
Extension 2
To properly investigate the change in the heat capacity as a function of temperature, the simulation should be carried out in NVT ensemble. To investigate the variation in heat capacity with temperature in NVT, 25 LAMMPS simulations were performed at 2.5 reduced unit pressure for the temperature range of 2.0-2.8.

The results showed no noticeable trend and the heat capacity fluctuated for the entire temperature range. The possible cause could be due to the small system size, and therefore the number of samples were not representative of the population. However, due to the long simulation time for larger systems, no further NVT investigation was performed. Good
Radial Distribution Function
The radial distribution function for the LJ system was calculated for solid, liquid and gaseous states using the phase diagram determined by Lin et al. [15]
The correlation function g(r), is defined as:
where and respectively corresponds to the local density at distance r and the bulk average density. Since the bulk density is the statistical average of the system, g(r) can represent the degree of order between the central particle and the surrounding species at distance r. If all species and the central particle at the origin are independent at r, simply and hence g(r) would equal 1. [16], [17]
![]() |
![]() |
For all three systems, when . corresponded to the separation at which the LJ potential became positive and hence, no atoms can exist at the distance less than this value. For the dense fluid, the first coordination shell, or the nearest neighbour, existed at and since reduced units were used, the first peak indeed occurred at 1. The second peak was observed again at which corresponded to the second coordination shell. The distance , corresponded to the intermediate region between the first and second coordination shell and hence g(r) was less than unity. The oscillatory behaviour was observed since some long range order was present in liquids. At very long distances, the g(r) converged to 1, meaning there was no order present between the central atom and the species at r. Tick
For the gaseous system, one peak was observed around but g(r) quickly converged to 1 beyond . As proven in the previous section, when the density of the system is low, the attractive interactions are more significant than repulsions and hence the local density was initially higher than the bulk. The range of correlation corresponded to the cutoff distance of as stated in the input file and therefore, no oscillatory behaviour was observed due to the short range order in the system. The behaviour of the liquid and gaseous systems agreed well with the MD study performed by Morsali et al. [18]
For ideal solids, a delta function was expected at the lattice points corresponding to the location of the atoms, and g(r) = 0 in interatomic locations. The behaviour was in contrast with liquid where g(r) ≠ 0 at , indicating the difficulty of diffusion in solids. However, some degree of broadening was always present above 0K due to the thermal vibrations. The Figures 17 and 18 illustrated this broadening effect as g(r) for Figure 18 was calculated at higher temperature than Figure 17. The Monte Carlo study by Choi et al, showed first three peaks located at 1.0125, 1.4575 and 1.7625, therefore the simulation results agreed with the literature. [19]Tick
The coordination number is given by the following relationship [16]
Therefore, the number integral of the first peak in Figure 20 represents the coordination number, corresponding to the first plateau in Figure 21. The number of atoms in the first coordination shell was found to be 12. Since all atoms in FCC lattice are equivalent, the coordination number for each first three peaks were also 12, as expected for maximum packing efficiency of FCC lattice. It is important to note that the number of atoms in the first coordination shell corresponds to the area under the peak not the height. Indeed, the number of atoms in the first coordination shell also corresponded to 12 (running integral read at r = 1.5). The difference in the number integral between the current peak integral value and the previous peak integral represents the number of atoms in each coordination shell. The maximum packing efficiency for the liquid and the solid systems ensured that the repulsions were minimised and also supported the argument that the atoms behave like 'hard-core' in LJ potential model.Tick
peak 1 | peak 2 | peak 3 | |
---|---|---|---|
vector | |||
Miller indices | [0, 1/2, 1/2] | [1,0,0] | [1, 1/2, 1/2] |
relative magnitude to d | |||
Running Integral | 12 | 18 | 42 |
Number of atoms in each shell | 12 | 6 | 24 |
Coordination number | 12 | 12 | 12 |
The lattice spacing corresponds to the nearest neighbour distance which was given by vector d:
Hence the relative magnitudes of other vectors can be calculated as:
Tick
The position of the first three peaks in solids were much closer to the central atom compared to liquid and gases. This decrease from distance in liquids was due to the bulk density of solid being higher than liquids. [16]. Furthermore, for solids g(r) did not converged to 1 within the range of r where the experiment was performed. The reasoning came from the fact that the first coordination shell was more ordered in solids than liquids. Ordering prohibited any species existing between the first two coordination shell and gave rise to the long range order in the subsequent coordination shells.Good

Diffusion
Task 1
The mean squared displacement plot showed the expected trend, for the inertial regime the increase was non-linear but at the diffusive regime the relationship became linear for liquid, gas and solids. For the gaseous plot, longer timestep was required compared to solids and liquids before the trend became linear. The diffusion coefficient was calculated by fitting a linear line of best fit in the linear region. For the gaseous systems, the calculated diffusion coefficient varied depending on the density the simulation was ran. Therefore, five simulations were performed at the density range 0.02-0.10 at constant T=1.2 and the calculated diffusion coefficients are shown in Figure 27.Tick
The inertial regime arises because when the particle initially start to move, their trajectories are unaltered as they do not encounter any neighbours. The motion of the atoms are much complex in this region but can be qualitatively simplified as the following. Since the collision is minimal, the velocity of the atoms remain almost constant. Hence, the distance the particles travel is approximately proportional to the time, and therefore the mean squared displacement is quadratic. In the diffusive regime, the motion of the particle resemble the random walk due to the fluctuating forces from the environment. Therefore, in diffusive motion the particle progress much less displacement per unit time than the inertial motion and obeys the Einstein equation. [16]
Calculated diffusion coefficients were compared to the study by Rowley et al. [20] and are summarised below. The dimensionless diffusion coefficient was given by:
[Solid] | [Liquid] | [Gas] | |
---|---|---|---|
This Study | |||
Rowley et al. | Tick |
The results from this simulation lied within 10% from the literature value. Both results showed that for the solids the diffusion coefficient was close to zero, and a higher value for gas compared to liquid. The average velocity of particles in gaseous system is higher than liquid and therefore the atoms are able to travel further in the given timestep leading to higher diffusion coefficient. Rowley et al used different system size, LJ cutoff value and different simulation time which were the main cause of the discrepancy.
The diffusion coefficient calculated from 1 million system size corresponded to , and for gaseous, liquid and solid systems respectively. Direct comparison with the previous simulation result was not possible as the output file did not state density and temperature the readings were taken. As shown in Figure 27, even within the same phase, the diffusion coefficient changes with different density and temperature.Tick
Task 2
The position and the velocity of the harmonic oscillator is given by:
Velocity autocorrelation function is given by:
use identity
let
use identity:
compared to t term, the sine term will be negligible in the limit of the integral
the divergence is the same on the denominator and the nominator and hence it is possible to cancel the integral
now consider the second integral. Use identity:
has rotational symmetry about the z axis and therefore the area over the x-axis is same as the area under the x-axis. Therefore, since the top and bottom limits are the same and the function also possesses the rotational symmetry, the positive area must equal negative area and hence the integral evaluates to zero.
therefore
overall
Tick

Task 3
![]() |
![]() |
Figure 29 shows the normalised VACF for liquid and solids at two different temperatures compared to the VACF of the harmonic oscillator derived in the previous task. The Green-Kubo formalism is a popular method of choice for diffusion coefficient calculation and is given as: [21]
where the angle brackets indicate averaging over the statistical ensemble.
is a measure of how well the velocity at time 0 correlate to velocity at time t. If there was a perfect correlation between velocity at t=0 and t, the product inside the angled bracket would always yield the same value and hence → and normalisation would result 1. If there is a no correlation → since the product inside the bracket will result in random values and hence the average over the ensemble is zero. For large t, the correlation function will tend to zero if the property of the system is statistically averaged out by the internal motions.
For the simple harmonic oscillator, the VACF is simply a cosine wave and the correlation is always one after each oscillation cycle because the particle always return to the original position with the same initial velocity. Therefore the velocity is perfectly correlated at every one period, perfect negative correlation at every half period and no correlation at a quarter and three quarter of the period. The harmonic motion can be represented as a projection of a circular motion on one axis and is schematically represented in Figure 31 below.Tick

Solid, liquid and gaseous systems showed very different VACFs for the reasonings outlined below. It is important to differentiate two different type of motions in the system; oscillatory and diffusive, and the dominance of one of the two motions will ultimately determine the shape of VACF. Oscillatory motion dominance will result in VACF resembling the harmonic oscillator as the atoms go back to the original position whereas diffusion dominance will result in VACF exponentially decaying as the system is statistically averaged out quickly.
For gaseous systems, VACF simply decayed exponentially as the Brownian motion dominated and due to the large interatomic distances, oscillatory behaviour was not possible. This system took the longest for VACF to reach zero because due to the small density the number of hard collision per unit time was less than the solid or liquid.[22] For liquid systems, a characteristic minima was observed followed by the negative correlation region before decaying to zero. The literature search showed that this was a well known phenomenon known as the "cage effect". [23] [24] The rebounding collision initially dominate over the scattering collision due to the high density of the liquid compared to the gaseous system. Therefore, the surrounding medium initially force oscillation over diffusion and each atom became locked in this "cage". However, frequent hard-core collisions in LJ liquid leads to quick statistical averaging and asymptotic decay of VACF to zero. For this system, the minima represented the timestep at which all particles have underwent at least one collision.Tick
In solids, the oscillatory behaviour dominates for longer duration as all the atoms are locked at the lattice site meaning there were no room for diffusion. For this system, the minima represented the timestep at which all particles have underwent at least one oscillation. Due to much higher packing efficiency in solid, the atoms are closer to each other than the liquid system and hence the observed minima occurred at earlier timestep. Furthermore, at lower temperature the minima was lower than the higher temperature VACF. This was due to the fact that the motion of the atoms were slower at lower temperature meaning it took longer time for statistical averaging to dominate. The fact that the period of the oscillation for solid at lower temperature was longer also supported this argument of slower motion.Tick
The diffusion coefficients were found by performing a linear fit at the plateaued region and extrapolating back to the y-intercept. For 1 million atom system size, it was not possible to perform the linear fit for the gaseous system as the system did not reach the diffusion regime within the timestep the experiment was performed. The results from Green-Kubo methods are summarised below
[Solid] | [Liquid] | [Gas] | |
---|---|---|---|
This study | |||
1 million atoms system size |
Comparing these results to the literature value from Task 1, Green-Kubo (G-K) method computed the diffusion coefficient of the liquid less accurately than the mean-squared displacement method. Literature search showed that G-K method was well known for overestimating the transport coefficient. [22]. There are both advantages and disadvantages for both methods. The main disadvantage of the G-K method was that, a very large system size was required. The comparison of Figures 32 and 34 revealed that for the larger system, the oscillations were smaller and the plateauing region was much more clearly defined. Furthermore, periodic boundary conditions altered the coordinates of the atom back to the original simulation box whereas in reality, the atom would move to the next box and therefore affect the velocity correlation calculations. These two factors would mean a longer computational time was required for the G-K method.Tick
Extension 3
Motivation
Study by Hansen et al [9] claimed to have observed the van der Waal's loop for the LJ model. It was therefore an interest to compare the current simulation results with this study to investigate the pressure dependence of the system as a function of density. This dependence was then compared with the van der Waal's equation to explore the validity of the equation to model the LJ system.
Methodology
The van der Waal's equation was modified to reduced units as follows:
therefore
now sub in everything to van der Waal's equation
The b term was set to zero as in LAMMPS simulations all atoms were treated as point particles. The values of a and N were kept identical to the parameters used in the LAMMPS simulations.
Results and Discussion
The results of the simulation are summarised in Figures 36 and 37 below:
![]() |
![]() |
The two figures above showed that van der Waal's equation agreed well for both temperatures at low densities as the system approached ideality. At T=1.5, no van der Waal's loop was observed. At T=0.75 the loop was observed due to the phase transition. At the first glance, the behaviour of the van der Waals equation at high density does not make sense. The equation predicted that the pressure would decrease as the volume of the system decrease. This was due to the fact that modelling the system as point particle was an extremely poor approximation to make in the van der Waal's equation at high density. The plot below shows the van der Waal's plot for constant temperature, number of particles, and the constant a but with varying b term.

Comparing the van der Waal's equation with Figure 36, it can be seen that as the value of the b term decreased, the vertical asymptote was moved in the negative x direction and therefore the term began to dominate at low densities. This domination forced the pressure to become more negative as the volume decreased. Therefore, modelling the LAMMPS simulation with van der Waal's equation where all atoms were point particles was a not a good idea at high densities.
The isothermal compressibility is given by the following equation:
The Figure below compared the plot of dp/dV against density between the van der Waal's equation and the LAMMPS simulation result. The derivative of the pressure and volume was calculated by fitting a curve to the results in Figure 37.

Again, the van der Waal's equation agreed very well with the LAMMPS simulation results at low densities. However, at high densities the van der Waal's equation predicted a completely unintuitive result; the system became more easier to compress at high densities. Again, this was due to the fact that b term was set to zero in the equation. Therefore, the van der Waal's equation was not a good model to use for point particle system at high densities.Good
References
- ↑ LAMMPS Manual Online atom_style, http://lammps.sandia.gov/doc/atom_style.html, (accessed 21/02/17)
- ↑ LAMMPS Manual Online units, http://lammps.sandia.gov/doc/units.html, (accessed 21/02/17)
- ↑ LAMMPS Manual Online mass, http://lammps.sandia.gov/doc/mass.html, (accessed 21/02/17)
- ↑ LAMMPS Manual Online pair_style, http://lammps.sandia.gov/doc/pair_lj.html, (accessed 21/02/17)
- ↑ LAMMPS Manual Online pair_coeff, http://lammps.sandia.gov/doc/pair_coeff.html, (accessed 21/02/17)
- ↑ N. H. Marsh and M. P. Tosi, Liquid State Physics , World Scientific Publishing Co., Singapore, 2002
- ↑ J. I. Choe and B. Kim, Chem Soc , 2000, 21, 419-424
- ↑ LAMMPS Manual Online fix ave/time, http://lammps.sandia.gov/doc/fix_ave_time.html, (accessed 21/02/17)
- ↑ 9.0 9.1 J. P. Hansen and I. R. McDonald, Theory of Simple Liquids Second Edition , Academic Press, San Diego, 1986 Cite error: Invalid
<ref>
tag; name "hansen" defined multiple times with different content - ↑ 10.0 10.1 D. Wallace, B. Holian, J. Johnson and G. Straub Phys. Rev. A, 1982, 26, 2882-2885
- ↑ D. Bolmatov and K. Trachenko, Phys. Rev. B, 2011, 84, DOI: 10.1103/PhysRevB.84.054106
- ↑ B. Sadigh and G. Grimvall, Phys. Rev. B, 1996, 54 , 15742-15746
- ↑ M. Forsblom and G. Grimvall, Phys. Rev. B , 2005 72 , DOI: 10.1103/PhysRevB.72.132204
- ↑ Hoffmann, R., 1987. How Chemistry and Physics Meet in Solid State., 26, 846-878
- ↑ S. T. Lin, M. Blanco and W. A. Goddard, 2003, J. Chem. Phys., 119, 11792-11805
- ↑ 16.0 16.1 16.2 16.3 D. Chandler, Introduction to Modern Statistical Mechanics , Oxford University Press, New York, 1987
- ↑ J. G. Kirkwood, V. A. Lewinson and B. J. Alder, 1952, J. Chem. Phys., 20, 929-938
- ↑ A. Morsali, E. K. Goharshadi, G. A. Mansoori and M. Abbaspour, 2005, Elsevier, 310, 11-15
- ↑ Y. Choi, T. Ree and F. Ree, 1991, J. Chem. Phys. , 95, 7548-7561
- ↑ R. L. Rowley and M. M. Painter, 1997, Int. J. Thermphys. , 18, 1109-1121
- ↑ V. Y. Rudyak, A. A. Belkin, D.A. Ivanov and V. V. Egorov, 2008, Pleiades Publishing, Ltd. , 46, 30-39
- ↑ 22.0 22.1 N. D. Kondratyuk, G. E. Norman and V. V. Stegailov, 2016, IOP Science , 774, 1-9
- ↑ M. Mouas, J-G Gasser, S. Hellal and B. Grosdidier, 2012, J. Chem. Phys , 136, 1-16
- ↑ S. Burov and E. Barkai, 2008, Phys. Rev. E , 78, DOI: 10.1103/PhysRevE.78.031112