Viscous Flow Computations with Molecular Dynamics

Size: px
Start display at page:

Download "Viscous Flow Computations with Molecular Dynamics"

Transcription

1 FAKULTÄT FÜR INFORMATIK DER TECHNISCHEN UNIVERSITÄT MÜNCHEN Bachelorarbeit in Informatik Viscous Flow Computations with Molecular Dynamics Ching-Yu Kao

2

3 FAKULTÄT FÜR INFORMATIK DER TECHNISCHEN UNIVERSITÄT MÜNCHEN Bachelorarbeit in Informatik Viscous Flow Computations with Molecular Dynamics Molekulardynamik-Simulationen für viskose Fluide Author: Ching-Yu Kao Supervisor: Prof. Dr. Hans-Joachim Bungartz Advisor: Dr. rer. nat. Philipp Neumann Date: September 15, 2013

4

5 Ich versichere, dass ich diese Diplomarbeit selbständig verfasst und nur die angegebenen Quellen und Hilfsmittel verwendet habe. München, den 8. Oktober 2013 Ching-Yu Kao

6

7 Abstract This research determined the viscosity of a fluid. To this end, molecular dynamics was used to simulate a channel flow environment. By applying a continuous external force on the channel, a parabolic velocity profile was obtained. By analysis of these profiles, the viscosity of the simulated fluid was computed. vii

8 viii

9 Contents Abstract vii 1 Molecular Dynamics The Aim and Motivation of Molecular Dynamics Lennard-Jones Fluid Periodic Boundary Condition Numerical Methods : Velocity-Stoermer-Verlet Algorithm The Cutoff Radius Viscosity Computation Computing Viscosity from Pressure The Viscosity from External Force Implementation of a Thermostat Velocity Scaling Modified Velocity Scaling Other Thermostats Results of Simulation D Environment D Environment Conclusion 45 Appendix 49 Bibliography 49 ix

10

11 1 Molecular Dynamics 1.1 The Aim and Motivation of Molecular Dynamics Computer simulation is a major tool for solving scientific problems or for predicting the properties of new materials. The most common atomistic computer simulation methods are Monte Carlo, Brownian dynamics, and molecular dynamics. The Monte Carlo method, which is the so-called stochastic strategy, depends on probabilities. Brownian dynamics is an approach used to simulate a large number of polymer molecules or particles in a small molecule. Molecular dynamics (MD), which is utilized in this work, is a very detailed method for systems composed of collections of particles consisting of molecules and/or atoms [2]. MD simulations compute the individual motions of each particle. MD efficiently evaluates different properties and dynamic quantities, which generally cannot be obtained by the Monte Carlo method [2]. It has been over 40 years since the first computer simulation of a liquid was carried out by the MANIAC super computer. The history of MD development is shown in Tab Several methods have been proposed to simulate the motion of a liquid. MD is one of the most widely used methods. By providing a theory of the interaction between particles, certain material properties can be determined from the simulation. On the other hand, theories can be tested by conducting experiments both inside and outside of the simulation. At times, it is necessary to carry out simulations under what would be an impossible situation in the laboratory, for example, for scenarios involving extreme temperature or pressure. A MD simulation is based on Newton s equations of motion, which, for a simple atomic system, can be written as f i = m i a i = m i r i = d dr i U (1.1) where f i is the force acting on atom i, U is potential energy of atom i as a function of the atom s separation from its neighbors, which will be described in detail in the following section, and r is the distance between atom i and it s neighbors. For the simulations conducted here, three-body (or more) potential energies were neglected. Of course, in a complex fluid, three-body (or more) potential energy must be taken into account. The procedure of the simulation is shown in Fig. 1.1, where including a thermostat, which we clarify in chapter 3. 1

12 1 Molecular Dynamics start Initialize positions and velocities Put molecules into linked cells Fill periodic boundaries Compute forces Empty periodic boundaries Apply thermostat Update new positions and velocities no Finish total time steps? Analysis of Trajectories yes Figure 1.1: The flow diagram representing the procedure of MD simulation conducted. 2

13 1.2 Lennard-Jones Fluid Table 1.1: History of MD computer simulation, derived from[18] Year System Required cpu time on a super computer[h] 1957 hard two-dimensional disks monatomic liquid 1971 molecular liquid molten salt simple small polymer protein in vacuo simple membrane protein in aqueous crystal DNA in aqueous crystal protein-dna complex in solution large polymers reaction macromolecular interactions protein folding Lennard-Jones Fluid Before initiating a MD simulation, some important properties of the liquid, including the environments and the numerical methods, must be introduced. Attractive Forces When atoms approach each other, there is a short-range force called the van-der-waals force which will attract one atom to another atom. As Fig. 1.2 shows, the approach of one atom to another distorts the electron distributions of both such that the positive electric charge of atom A will attract the negative electric charge of atom B, and this phenomenon draws atoms A and B towards one another. In mathematical form, the van-der-waals potential is written as U 1 (r ij ) = 4ɛ( σ r ij ) 6 (1.2) where σ is the particle diameter and ɛ is the interaction strength(energy). Repulsive Forces In addition to attractive forces, there is also a repellent force, otherwise all the atoms would simply gather together. The closer atoms approach, the stronger will be this repellent force. This repulsive force is so-called Pauli-repulsion, and its formulation is: U 2 (r ij ) = 4ɛ( σ r ij ) 12 (1.3) The Lennard-Jones pair potential energy combines U 1 (r ij ) and U 2 (r ij )[12]: 3

14 1 Molecular Dynamics Atom A Atom B Figure 1.2: : A schematic representation of the van-der-waals attractive force. As the schematic presents, when two atoms approach each other, they are attracted owing to distortions in their electron distributions [8]. U LJ (r) = 4ɛ[( σ r )12 ( σ r )6 ] (1.4) This mathematical formulation is for the properties of the liquid argon, which is shown as Fig Lennard Jones Potential U Distance between two particles (r) Figure 1.3: Interaction force of Lennard-Jones fluid from Eq The depth of the potential is determined by ɛ and diameter of the particle is σ. 4

15 1.3 Periodic Boundary Condition Result: Force computation for a particle i using the linked cell method. for all ic do for all particles i in ic do force(i) = 0; for all cells kc in N(ic) do for all particles j in the cell kc do if i j and r ij r cut then force(i) + = force(ij); end end end end end Algorithm 1: Force computation for particles. Adjusted in[16] 1.3 Periodic Boundary Condition In the microscopic world, one very difficult task is to set boundaries around the system to be simulated. From the standpoint of molecular behavior, the interaction between an actual boundary and a particle of a liquid is very complex, and the issue must be considered very carefully. Additionally, another problem reflects the capacity of the computer, such that large systems require a great amount of computational resources. There are several boundary conditions that might be used in simulations. For example, the first is to adopt no boundaries, or what is called a free boundary simulation. However, this boundary condition requires the simulation of a quite huge system. As was mentioned before, the capacity of a computer is restricted and simulation using a large domain might require excessive computational resources. One method of solving this problem is to use periodic boundary conditions, as shown in Fig This boundary condition allows the simulation of a small section of a large system. Under these conditions, each particle in the computational cell is interacting not only with the other particles in the computational cell, but also with their images in neighboring cells. Under a periodic boundary condition, a central cell containing all the particles of interest is established. When a particle located in the central cell moves, its periodic images in every other cell move with exactly the same velocity. Thus, as a particle leaves the central cell, one of its images will enter again through the opposite side. As such, the central cell contains no walls, and the system has no surfaces to account for. Of course, there are still other possible boundary conditions, such as mixed boundary conditions. Mixed boundary conditions involve periodic boundaries in certain directions and free or fixed boundaries 1 in the other directions. This boundary condition is used in the present simulation of channel flow. Other boundary conditions could be potentially applied to the present study, such as stochastic boundary conditions in which the boundary is more energetic and episodic than quasi-periodic [3], or dynamic pressuretransmitting boundary conditions which prevent reflection of the pressure wave out of the simulation domain [4]. While selection of boundary conditions based on physical grounds 1 Here the fixed boundary means the upper and lower walls. 5

16 1 Molecular Dynamics has been difficult so far [3], nevertheless, for reasons of simplification, mixed boundary conditions are applied to the present study. Figure 1.4: A 2D schematic representation of periodic boundary conditions showing a central cell containing the particles of interest surrounded by eight image cells. Only the behavior of the central box has to be simulated, other boxes behave in the same way. 1.4 Numerical Methods : Velocity-Stoermer-Verlet Algorithm Several numerical methods to solve Newton s equations of motion exist. The most common methods are the standard Verlet algorithm, Velocity-Stoermer-Verlet algorithm and the Leapfrog Algorithm [6]. Velocity-Stoermer-Verlet algorithm is used in this work. The Taylor expansion about r(t + δt) and r(t δt) is : r(t + δt) = r(t) + r (1) ((t + δt) t)1 (t) + r (2) ((t + δt) t)2 (t) + r (3) ((t + δt) t)3 (t) + O 4 (δt) 1! 2! 3! (1.5) r(t δt) = r(t) + r (1) ((t δt) t)1 (t) + r (2) ((t δt) t)2 (t) + r (3) ((t δt) t)3 (t) + O 4 (δt) 1! 2! 3! (1.6) Then, from Eq Eq. 1.6, we obtain: 6

17 1.5 The Cutoff Radius r(t + δt) = 2r(t δt) r(t δt) + r (2) (t)δt 2 + O 4 (δt) (1.7) where r(t) is the position of a particle at step t and r (2) (t) is the acceleration of the particle. Since we have the position of the particle at time step t+δt, the velocity can be calculated as v(t) = r(t + δt) r(t δt) 2δt where v(t) is the velocity of a particle at time step t. However, there is a disadvantage of this method, which is the possibility of large rounding errors occurring with the addition of values of very different magnitudes [16]. This problem occurs because δt is small, and, such as δt 2 is much smaller, which makes r (2) (t)δt much smaller than the other terms in Eq A variant of this method, which is not susceptible to the rounding error discussed above, is the Velocity-Stoermer-Verlet algorithm. Upon solution of Eq. 1.8, the result of Eq. 1.8 and replace r(t + δt) in Eq. 1.7, and thereby obtain: (1.8) r(t + δt) = r(t) + δtv(t) + r(2) (t)δt 2 In addition, from Eq. 1.5 and Eq. 1.6, the following is derived: 2 (1.9) v(t) = = r(t) δt r(t + δt) r(t δt) 2δt r(t δt) δt + r(2) δt 2 (1.10) (1.11) As a result, the following formula can be obtained by adding the corresponding v(t+δt): v(t + δt) = v(t) + (r(2) (t) + r (2) (t + δt))δt 2 (1.12) The steps involved with calculation of the Velocity-Stoermer-Verlet algorithm are shown in Fig The three algorithms require nearly the same capacity of memory and the accuracy of the three methods is given as O(δt 2 ). 1.5 The Cutoff Radius In principle, we evaluate all pair the interaction force, no matter how far these two particles are separated. However, for the non-bonded interactions 2, in each time steps, we 2 Non-bonded interaction means two interaction between two single particles. Here the non-bonded interaction is Lennard Jone potential. 7

18 1 Molecular Dynamics r v F t-dt t t+dt t-dt t t+dt t-dt t t+dt t-dt t t+dt Figure 1.5: A schematic of the steps involved with calculating the Velocity-Stoermer-Verlet algorithm. need to consider all the forces between two particles, it involved all pairs of particles, therefore require O(n 2 ) computing time. However, by enforcing a limit on the number of interactions considered, it is possible to reduce the computational time to O(n). This can be accomplished by introducing a cut-off radius. With a cut-off radius, the interactive forces between two particles are not computed if the distance of separation between the two atoms is beyond the cut-off radius. Such neglect makes sense since some interactive forces decrease strongly with distance, such as the van der Waals force. The three main methods for determining collections of particles for which interactions are to be calculated are the all-pair method, the Verlet neighbor-list method [5] and the linked cell list [17]. The All-Pair Method The all pair method involves no cut-off radius and all non-bounded interactive forces between any two atoms must be computed. Assuming that N particles are involved in the simulation, the force is computed: Verlet Neighbor-List Methods F i = N j=1,j i F ij (1.13) The Verlet neighbor list method constructs a list, which includes all particles j, whose distance from particle i is smaller than the distance r verlet. Namely, r cut r verlet (1.14) Obviously, it requires computational resources to check if a particle is still in the range of the cut-off radius. However, since the time step is quite small, it is known that most of the particles will remain in the range of the cut-off radius for many time steps. This indicates that it should be unnecessary to update the Verlet-list at every time step. With that said, there is an increasingly intuitive method of determining the range of the cut-off radius, which is called the linked-cell method. Linked-Cell Subdivision The concept of the linked cell method is to divide the simulation domain Ω into uniform sub-domains, so-called cells, so that the potential of one particle will be limited to the cell in which it is located and to its adjacent cells. It must be noted that the cell size is larger 8

19 1.5 The Cutoff Radius than the cut-off radius r cut. Since not all the forces among the particles are calculated, Eq is rewritten as: F i = ( cell kc,kc N(ic) j particlesincellkc,j i F ij ) (1.15) where N(ic) is cell kc and its neighbored cells. Fig. 1.6 illustrates how the linked cell size is defined from a given cut-off radius. Fig. 1.7 illustrates the combination of periodic boundary conditions with the linked-cell method. The Alg. 1 represents the force computation using the linked cell method. Figure 1.6: A schematic illustrating the linked cell method, derived from [16] Figure 1.7: A schematic illustrating the combination of the linked cell Method with periodic boundary conditions. 9

20 1 Molecular Dynamics 10

21 2 Viscosity Computation The viscosity is a crucial property of a liquid, and different viscosities represent different liquids at varied temperatures, as given in Tab For example, water has a lower viscosity than oil at room temperature. Because different liquids have different viscosities, viscosity is an important factor not only in chemistry but also in industry. There are several methods available to obtain the viscosity of a fluid from MD simulations. These methods can be divided into two major groups: equilibrium methods and non-equilibrium methods [13]. When viscosity is computed from system pressure, this method belongs to the equilibrium method. Another equilibrium method for calculating viscosity uses momentum. A non-equilibrium method includes periodic shear flow, which makes use of the steadystate shear. The main aim of this section is to highlight the importance of the viscosity of a fluid and to examine various computation methods. 2.1 Computing Viscosity from Pressure The viscosity can be calculated from an equilibrium MD simulation by the following Green- Kubo formula: η = V k B T 0 P xz (t 0 )P xz (t 0 + t) t0 dt (2.1) where η is the viscosity we expected, P xz is the component of the molecular stress tensor P of the system in the xz-plane [14]. The method converges very slowly because the pressure of the constant volume simulation cell fluctuates widely. Hess has compared the equilibrium methods computed based on pressure and the momentum formulations to non-equilibrium methods in MD simulations. His results show that, despite their undoubted advantages, both equilibrium methods suffer from worse statistics than non-equilibrium methods [11]. Table 2.1: Some common materials with different viscosities at different temperature. Liquid Absolute Viscosity[cP(1cP = 1 kg/(ms))] Temperature [Celsius] Milk Milk Butter Fat Butter Fat Olive Oil Mayonnaise Wax

22 2 Viscosity Computation 2.2 The Viscosity from External Force Simulation of Molecular Dynamics Channel Environment with Different Setups Velocity Profiles Viscosity Calculation Analysis and Comparison Figure 2.1: A flow diagram of receiving viscosity. In order to determine the viscosity from channel flow, an approach to simulate channel flow are introduced. First, the geometry, such as that of upper and lower walls, is established to simulate channel flow. Afterwards, several profiles are taken as input data from a simulation involving N time-steps, to determine the viscosity. H is the height of the channel, and V x is the velocity along the x axis, f is an external force along the x axis, and the fluid density is ρ, Fig. 2.2 [13]. The velocity profile in the channel is related to the viscosity by the formula: ν d2 u dy 2 = (g x) (2.2) where ν is viscosity, H is the height of the channel, and g x is acceleration in x direction. The total force F on the MD system is given by: N F = F i (2.3) movingmolecules:i=1 12

23 2.2 The Viscosity from External Force Because F = mg, of which m is molecule mass. F = m N i=1 g i F = mng x, in which mn is the total mass of all molecules. Hence the velocity profile provides the following: g x = F mn = F i m (2.4) In the present case, since m = 1 it follows g x = F i In velocity profile, from V x = g xy(h y) 2ν which indicates that the viscosity can be determined as (2.5) ν = g xy(h y) 2V x (2.6) Fig. 2.1 represents the procedure to obtain the viscosity in this report. Fixed Upper Wall force H z = channel height x =channel length Fixed Lower Wall Figure 2.2: Open channel flow involving fixed upper and lower boundaries, and periodic boundary conditions are applied to the left and right sides only. 13

24 2 Viscosity Computation 14

25 3 Implementation of a Thermostat When conducting simulations of NVT ensembles, the number of particles (N), the system volume(v), and the temperature (T) of a simulation system must be held constant. Before a simulation is begun, the volume is fixed and the number of particles included within the system in conjunction with the volume corresponds to the density of the fluid. Therefore, the liquid density determines the relationship between the number of particles and the volume. Because an external force is imposed along the x axis, the temperature is expected to increase, as illustrated in Figs This is undesirable because the higher temperature will yield a lower viscosity for the fluid. Hence, it is necessary to establish a method of holding the temperature constant. One such method is to apply a thermostat. A thermostat is a method of maintaining a given temperature by adjusting particle velocity or momenta. Classical constant-temperature calculations have been pursued for over a decade [10]. Various thermostats will be introduced in this report. For a NVT simulation, the number of particles and the domain size are constant, but the energy of the system is not. Focusing upon the energy of the system, it can be described by the Hamiltonian equation: which can be reformulated using the momentum p i as H = 1 2 m iv i 2 + U(r) (3.1) H = p i 2 2m i + U(r) (3.2) dr i dt = H p i, dp i dt = H r i (3.3) Therefore, the above formulas indicate the means to modify or control the temperature of a system by adjusting the velocity of the particles directly or by changing the momentum P (since P = n i=0 m i v i, both methods are equivalent). One such method of reducing the velocity of particles is by applying a friction force. In the following sections, some wellknown thermostats are introduced. 3.1 Velocity Scaling First, a simple method to adjust the velocity of particles directly is introduced. The temperature is related to the kinetic energy of the system by: E kin = 1 2 m i v i 2 i (3.4) 15

26 3 Implementation of a Thermostat Thermostats for 3D Environment, Target Temperature = 1.8 velocity rescaling along y direction velocity rescaling with whole direction 2.8 temperature time-step Figure 3.1: The temperature with a thermostat having been applied only along the y direction (see Eq. 3.10) and with the thermostat applied in all directions( see Eq. 3.11). In this comparison, the initial given temperature is 3.1, the target temperature is 1.8. At the beginning, the temperature needs several steps to be pushed to the target temperature. 16

27 3.2 Modified Velocity Scaling Additionally, the kinetic energy of the system can be described by: E kin = 3Nk BT (3.5) 2 Here, 3N is the total number molecules in the domain having three degrees of freedom, k 1 B is Boltzmann constant, T is the temperature. Thus, setting Eq. 3.4 equal to Eq. 3.5, the temperature is given as T = 2E kin = 2 Ni=1 m i (v i ) 2 2 (3.6) 3Nk B 3Nk B Under condition where T goal T current, the current temperature can be adjusted to the target temperature by rescaling the velocity in accordance with: v n i = βv n i (3.7) β = Ê Ttarget T current (3.8) In this manner, the thermostat will adjust the velocities of particles to ensure that the average temperature of the system remains stable. However, because the value of β will effect the distribution of energy in the system quite strongly, a modified damping factor γ, γ [0, 1], γ dt is introduced [7]: Ê β revised = 1 + γ(( T target ) 1) (3.9) T current As was shown above, a system at a constant temperature can be obtained by adjusting the velocity of each particle. However, accurate velocity data is a requirement of accurately determining the viscosity of a fluid. Two ways exist to solve this problem. 3.2 Modified Velocity Scaling As we can see from the formula above, by adjusting the velocity of each particle, we can obtain a system with constant temperature. But, we do need those velocity data to determine the viscosity of the fluid. For the reason of that, there are two ways to solve this problem. First, we apply a thermostat only to the velocities along the y-direction or only along the z-direction. That is: v n yi = βv n yi (3.10) Or, we apply a thermostat to the velocities along the whole directions, which is the following formulation: v i = v + β(v i v) (3.11) A comparison of these two temperature-rescaling results is shown as Fig k B is J/K 17

28 3 Implementation of a Thermostat 3.3 Other Thermostats Some other thermostats will be presented in our work in the following part. The Nose-Hoover thermostat method is also be known as the extended-langrangian approach [9]. The concept of this thermostat is to use a friction factor to control the velocities of particles. First, a virtual parameter s 1 is made to multiply the actual timescales dt, so that a new, virtual timescale d t is produced: d t = dt s (3.12) where the relation between the actual variables (coordinates r i, momenta p i )and the virtual variables (coordinates r i momenta p i ) are: r i = r i, p i = p i s (3.13) d r i d t = sdr i dt = sṽ (3.14) As a result, the Hamiltonian function given in Eq.3.2 of the extended system is: H Hoover = p 2 i 2m i s 2 + U(r) + p 2 s + gkt ln(s) (3.15) 2M s in which the first two terms represent the original system and the last two terms are the kinetic energy and potential energy of the extended system. According this extended Hamiltonian, it is known that the new velocities of the particles in virtual time t are: r i dt = H Hoover = p i p i m i s 2 (3.16) p i dt = H Hoover = U r i r i (3.17) dp s dt = H Hoover s ds dt = H Hoover p s = pi 2 m i s 2 gkt s = p s M s (3.18) (3.19) The velocity and the acceleration of particles are rescaled by the additional and dimensionless degree of freedom s, the system is thus with a stable temperature. The idea of the Anderson thermostat is to supplement a stochastic collision term in the equation, with acting particles randomly selected. Each stochastic collision of those particles influences the system momentum. The Langevin thermostat can be used by adding a frictional force to the motion of the particles. At each time step δt, the Langevin thermostat changes the motion of particles so that the momenta are also changed. The Langevin equation is given by: r (2) i new = r(2) i γr (1) i + ξ (3.20) 18

29 3.3 Other Thermostats where r (2) i is the acceleration of a particle i, γ is a frictional coefficient and ξ is a randomly generated noise. The Berendsen thermostat provides a modification parameter λ to the momenta P : P = λp (3.21) Ê λ = δt ( T target 1) (3.22) τ T T current where τ T is coupling time constant, which determines the time scaling. In [1], researchers compared different thermostats, including velocity rescaling, Nose- Hoover, and Andersen-thermostats, or wall-fluid coupling, for a Poiseuille flow 2 in a nanochannel. The methods were compared using analysis of fluctuations and time averaged quantities. In the study, researchers applied a gravity force along the z axis, very much like the external force along the x-axis proposed in this work. It was suggested that the desired temperature was quickly obtained after a single time-step. The Nose-Hoover thermostat was determined to require about ten time-steps to reach the target temperature. While the Nose-Hoover demonstrated an advantage that it did not depend on numerical methods, in comparison with the method of velocity rescaling, the method of velocity rescaling exhibited smaller fluctuation amplitudes, provided the numerical time step was small. For reasons of simplicity, the velocity rescaling was chosen as the thermostat for use in the present study. 2 Poiseuille flow is what is called channel flow in this report. 19

30 3 Implementation of a Thermostat 20

31 4 Results of Simulation The major aim of this work is to understand the relation of the accuracy and the simulation time when computing the viscosity from MD. We tried to achieve the simulation of molecular dynamics through a variety of measures. In the following section we develop experiments in both 2D and 3D. In the following simulations, the velocity rescaling thermostat is used to keep the temperature constant. Besides, in order to estimate the equilibrium time and sampling time, simulations were conducted on a mac computer with a 1.8 GHz Intel Core i5 processor and 8 GB of 1600 MHz DDR3 memory D Environment 2D experiments were conducted employing the parameters applied in the research of Succi[12], which provides some fixed parameters and results like that shown in Fig The physical properties are defined in Tab. 4.1, and were not changed in the experiment. The Domain size was given as , which indicated a total number of particles of The corresponding particle distribution is 181 molecules along the x axis and 93 along the y axis. The external force applied along the x-axis is f x = 02. The cut-off radius is defined as 1.122, so a linked cell size of 2 was chosen. After 10 5 steps without an external force, steps were conducted to reach an equilibrium state. However, the results did not fit in with the assumptions given in [12]. Although another further attempt was made, the results from that attempt were no different from the first trial D Environment The 3D environment simulation utilized the fixed parameters described in Werder s study [15], as given in Tab Initially, the particle system looks like that shown in Fig. 4.2, where each particle is set on a fixed grid. Before applying an external force at the walls in the channel simulation, 10 4 time steps were employed to produce the random state shown in Fig This random state was used for the simulation conditions including an external force and the desired geometries. Table 4.1: Physical Property of 2D[12] Density σ f x Temperature Viscosity

32 4 Results of Simulation 0.07 Fit equation is :-00236*x^ *x Figure 4.1: A 2D simulation using parameters given in [12]. However, the maximum velocity in [12] is given by 0.5, where our simulation result has maximum velocity. Table 4.2: Physical Property of 3D Density σ Pressure Temperature Avg. Viscosity

33 4.2 3D Environment To evaluate the error of the simulation, three methods were considered. First, the average viscosity was calculated, and comparisons were made with the expected viscosity. Second, the error between the measured maximum velocity and the analytical maximum velocity were investigated, which is calculated according to the following formula: v ana max v measure max v ana max Third, a quantification method was utilized to obtain the error as follows: ( (v ana v measure ) 2 ) 1 2 ( (v ana ) 2 ) 1 2 (4.1) (4.2) Figure 4.2: A 3D simulation demonstration. Before the simulation, the particles are set on a fixed grid. Generally speaking, MD simulations encounter three main problems that must be determined. First, the size of the configuration space that is accessible to the molecular system must be established. Specifically, how large should the simulation domain be? Will a smaller domain produce worse results? Second, the accuracy of the cut-off radii that are used to model the particle system must be determined. Third, adequate equilibrium and sampling times must be determined. The following strategies were employed to determine the most effective simulation methodology. Because of the first problem, the 3D simulations were conducted with different domain sizes in order to determine the extent to which a smaller domain affected the accuracy of the results. Three domain sizes were introduced: Normal domain (x, y, z) = (9, 24, 24), Smaller X (x, y, z) = (9, 24, 24)), and Smaller XY (x, y, z) = (9, 9, 24). Smaller domains definitely produce faster results, but another method that will reduce computing time is 23

34 4 Results of Simulation Figure 4.3: A 3D demonstration after 10 5 time steps wherein the simulation has reached a random state. Figure 4.4: A schematic describing the bi-direction force used to reduce fluctuation near the walls, derived from [13] 24

35 4.2 3D Environment the use of a smaller cut-off radius. In Werder s study, the cut-off radius employed was An additional simulation using a smaller cut-off radius was investigated to evaluate the error rate. Regarding the problem of accuracy, there are several ways to investigate this issue. First, a new method employed in [13], which is referred to here as the bi-direction force method (see Fig. 4.4) was utilized. In the study of [13], the researchers suggested that two different directed forces with a simple periodic boundary condition could be applied with this method, and that the fluctuation near the walls could be reduced by removal of the fixed walls. Because the walls were not required in this case, the height of z was redefined as 18 instead of 24, providing a wall thickness of 3. Because of the fixed geometries, namely that of the upper and lower walls, fluctuations will obviously be greater than that obtained with pure periodic boundaries. This new method was implemented using the algorithm described in Alg. 2. Result: Opposite directed forces Applied for particles initialization; for all linked cells ic do for all particle i in ic do if position(i) channel height 2 then force(i) += external force; else force(i) -= external force; end end end Algorithm 2: Implementation of the bi-direction force method. Second, points close to the walls were ruled out and only the inner points were considered. This method is here called the inner linked cells method. It was expected that this strategy would provide a better result then considering the all linked cells. As was employed with the other methods, this strategy also employed three different domain sizes. The successive pictures, Fig. 4.5 to Fig represent the best fit equations on the right side and the modified fit function on the left side using different approaches. To determine the best fit curve, it was assumed that the data has an expression: n 1 [w 0, w 1, w 2 ] = argmin [w0,w 1,w 2 ] R 3 ((y i (x 0 w 0 + x i w 1 + x 2 i w 2 )) 2 ) (4.3) where w i is the coefficient of point i, and the fit equation matches this condition. Therefore, the best fit equation was determined using the least square method. More specifically, we have: y 0 1 x y 1 0 x 2 ɛ x 1 x 2 w 0 ɛ 1 1. =. w (4.4) 1 x n 2 x 2 w 2 n 2 y n 2 y n 1 0 ɛ n 2 ɛ n 1 25

36 4 Results of Simulation The matrix in 4.4 can be reformed as w = argmin ɛ=b Aw ɛ 2 The optimal values of w are found by using simple matrix operations: 2 (4.5) w = (A T A) 1 A T y (4.6) However, the best fit equation cannot ensure that the velocity curve at the walls is zero; therefore, some adjustments must be made. Since the original fit is to an equation of the form of ax 2 + bx + c, the coefficients a,b, and c must be modified to make the fit reasonable. The figures from Fig to 4.31 are the simulation results using bi-directional forces for different samples. The figure on the far right is the original simulation result after applying the bi-directional force method. The figure in the middle is the result after averaging the corresponding points and its best fit equation. The figure on the far left is the fit equation after adjustment. Here, the z axis is not 24, but 18, because, with a bi-direction force, no walls need be established in the domain. Therefore, in order to obtain the same size of simulation domain as before, z is set to 18 instead of 24. Fig. 4.5 shows the velocity profiles of the configuration having a domain size(x, y, z) = (24, 24, 24) using various sample numbers. The error with the use of velocity profiles of the parabolic fit has a deviation of 2.5% from the, and an estimate of the viscosity is thus obtained with an error of less than 2.7%. The computation required more than 26 hours using the previously described computer resources to reach equilibrium and needed more than 12 days to complete the sampling. The same domain size using velocity samples also had quite similar results as that using samples. Taking even fewer samples, namely 5000 samples, the deviation from the is approximately 4% and the error of the viscosity measurement is about 4.4%. In this case, considering the result of sampling only the inner cells, the deviation is under 2%, whether using 20000, 10000, or 5000 samples. Clearly, these results are better than that by sampling all the linked cells. As shown in Fig. 4.10, changing the size of x to 9 while retaining the size of y and z, more than 14 hours were required to obtain equilibrium. The fit equation has a deviation of 3.4% from the using samples, 4.7% using samples, and 7.2% using 5000 samples; hence, the errors in the viscosity are 3.6%, 5.6% and 7.5%, respectively. For this domain size, the samples from inner linked cells provide better results as well, and all the errors for the viscosity are under 5.5%. To determine if a smaller domain affects the precision of simulation results, domains of smaller size in both the x and y directions, namely (x, y, z) = (9, 9, 24), are examined. From Fig. 4.13, with the domain size of x = 9 and y = 9, the error of the fitted results for samples is 3.7%; therefore, the viscosity error is approximately 2.2%. The deviation of the fitted results for samples is also 4.3%, of which the corresponding viscosity error is 4.4%. In this case of the simulation using 5000 samples, quite a large deviation of about 12% is observed, and the error in the viscosity is more than 14%. Fig shows the results using the bi-direction method. These simulations required about a day to reach equilibrium and then sampling with profiles required more than 10 days. The results indicate that deviations from the are 1.2% with samples, 4.7% with samples, and 7.5% with only 5000 samples. The respective viscosity errors are 2.4%, 6.7% 26

37 4.2 3D Environment Fit equation is :-0652*x^ *x Fit equation is :-0658*x^ *x velocity along the x direction Figure 4.5: 3D-simulation of open channel flow using Normal size with walls, (x, y, z) = (24, 24, 24), for samples, cut-off radius 2.96 Fit equation is :-0676*x^ *x Fit equation is :-0676*x^ *x velocity along the x direction Figure 4.6: 3D-simulation of open channel flow using Normal size with walls, (x, y, z) = (24, 24, 24), for samples, cut-off radius of 2.96 Fit equation is :-0642*x^ *x Fit equation is :-0638*x^ *x velocity along the x direction Figure 4.7: 3D-simulation of open channel flow using Normal size with walls, (x, y, z) = (24, 24, 24), for 5000 samples, cut-off radius of

38 4 Results of Simulation Fit equation is :-0646*x^ *x Fit equation is :-0640*x^ *x velocity along the x direction Figure 4.8: 3D-simulation of open channel flow using Smaller X and walls, (x, y, z) = (9, 24, 24), for samples and cut-off radius of Fit equation is :-0636*x^ *x Fit equation is :-0636*x^ *x velocity along the x direction Figure 4.9: 3D-simulation of open channel flow using Smaller X and walls, (x, y, z) = (9, 24, 24), for samples and cut-off radius of Fit equation is :-0621*x^ *x Fit equation is :-0621*x^ *x velocity along the x direction Figure 4.10: 3D-simulation of open channel flow using Smaller X and walls, (x, y, z) = (9, 24, 24), for 5000 samples and cut-off radius of

39 4.2 3D Environment Fit equation is :-0643*x^ *x Fit equation is :-0643*x^ *x velocity along the x direction Figure 4.11: 3D-simulation of open channel flow using Smaller XY with walls, (x,y,z) = (9,9,24) for samples, cut-off radius of Fit equation is :-0640*x^ *x Fit equation is :-0640*x^ *x velocity along the x direction Figure 4.12: 3D-simulation of open channel flow using Smaller XY with walls, (x,y,z) = (9,9,24) for samples, cut-off radius of Fit equation is :-0587*x^ *x Fit equation is :-0588*x^ *x velocity along the x direction Figure 4.13: 3D-simulation of open channel flow using Smaller XY with walls, (x,y,z) = (9,9,24) for 5000 samples, cut-off radius of

40 4 Results of Simulation Fit equation is :-0664*x^ *x Fit equation is :-0657*x^ *x velocity along the x direction Figure 4.14: 3D-simulation of open channel flow using Normal size with walls, (x, y, z) = (24, 24, 24) for samples, only inner cells are taken, cut-off radius of 2.96 Fit equation is :-0657*x^ *x Fit equation is :-0667*x^ *x velocity along the x direction Figure 4.15: 3D-simulation of open channel flow using Normal size with walls, (x, y, z) = (24, 24, 24) for samples, only inner cells are taken, cut-off radius of 2.96 Fit equation is :-0657*x^ *x Fit equation is :-0644*x^ *x velocity along the x direction Figure 4.16: 3D-simulation of open channel flow using Normal size with walls, (x, y, z) = (24, 24, 24) for 5000 samples, only inner cells are taken, cut-off radius of

41 4.2 3D Environment Fit equation is :-0646*x^ *x Fit equation is :-0655*x^ *x velocity along the x direction Figure 4.17: 3D-simulation of open channel flow using smaller size with walls, (x, y, z) = (9, 24, 24) for samples, only inner cells are taken, cut-off radius of 2.96 Fit equation is :-0640*x^ *x Fit equation is :-0645*x^ *x velocity along the x direction Figure 4.18: 3D-simulation of open channel flow using smaller size with walls, (x, y, z) = (9, 24, 24) for samples, only inner cells are taken, cut-off radius of 2.96 Fit equation is :-0660*x^ *x Fit equation is :-0661*x^ *x velocity along the x direction Figure 4.19: 3D-simulation of open channel flow using smaller size with walls, (x, y, z) = (9, 24, 24) for 5000 samples, only inner cells are taken, cut-off radius of

42 4 Results of Simulation Fit equation is :-0638*x^ *x Fit equation is :-0641*x^ *x velocity along the x direction Figure 4.20: 3D-simulation of open channel flow using smaller size with walls, (x, y, z) = (9, 9, 24) for samples, only inner cells are taken, cut-off radius of 2.96 Fit equation is :-0621*x^ *x Fit equation is :-0616*x^ *x velocity along the x direction Figure 4.21: 3D-simulation of open channel flow using smaller size with walls, (x, y, z) = (9, 9, 24) for samples, only inner cells are taken, cut-off radius of 2.96 Fit equation is :-0563*x^ *x Fit equation is :-0562*x^ *x velocity along the x direction Figure 4.22: 3D-simulation of open channel flow using smaller size with walls, (x, y, z) = (9, 9, 24) for samples, only inner cells are taken, cut-off radius of

43 4.2 3D Environment Fit equation is :-0568*x^ *x Fit equation is :-0568*x^ *x velocity along the x direction analysis solution Figure 4.23: 3D-simulation of open channel flow using a domain size (x, y, z) = (24, 24, 24) and a smaller cut-off radius of 1.5 for samples. Fit equation is :-0573*x^ *x Fit equation is :-0574*x^ *x velocity along the x direction analysis solution Figure 4.24: 3D-simulation of open channel flow using a domain size (x, y, z) = (24, 24, 24) and a smaller cut-off radius of 1.5 for samples. Fit equation is :-0545*x^ *x Fit equation is :-0545*x^ *x velocity along the x direction analysis solution Figure 4.25: 3D-simulation of open channel flow using a domain size (x, y, z) = (24, 24, 24) and a smaller cut-off radius of 1.5 for 5000 samples. 33

44 4 Results of Simulation Fit equation is :-0423*x^ *x Fit equation is :-0422*x^ *x velocity along the x direction Figure 4.26: 3D-simulation of open channel flow using a domain size (x, y, z) = (24, 24, 24) for a cut-off radius of 1.0 for samples. Fit equation is :-0425*x^ *x Fit equation is :-0425*x^ *x velocity along the x direction Figure 4.27: 3D-simulation of open channel flow using a domain size (x, y, z) = (24, 24, 24) for a cut-off radius of 1.0 for samples. Fit equation is :-0394*x^ *x Fit equation is :-0391*x^ *x velocity along the x direction Figure 4.28: 3D-simulation of open channel flow using a domain size (x, y, z) = (24, 24, 24) for a cut-off radius of 1.0 for 5000 samples. 34

45 4.2 3D Environment Fit equation is :-0659*x^ *x analysis solution velocity along the x direction Fit equation is :-0664*x^ *x analysis solution Fit equation is :-0050*x^ *x^ *x with thermostat Figure 4.29: 3D-simulation of open channel flow without walls and applying two different direction forces in the channel using a domain size (x, y, z) = (24, 24, 18) for samples, cut-off radius of Fit equation is :-0634*x^ *x analysis solution velocity along the x direction Fit equation is :-0633*x^ *x analysis solution Fit equation is :-0048*x^ *x^ *x with thermostat Figure 4.30: 3D-simulation of open channel flow without walls and applying two different direction forces in the channel using a domain size (x, y, z) = (24, 24, 18) for samples, cut-off radius of Fit equation is :-0617*x^ *x analysis solution velocity along the x direction Fit equation is :-0618*x^ *x analysis solution Fit equation is :-0046*x^ *x^ *x with thermostat Figure 4.31: 3D-simulation of open channel flow without walls and applying two different direction forces in the channel using a domain size (x, y, z) = (24, 24, 18) for 5000 samples, cut-off radius of

46 4 Results of Simulation domain size = (24,24,24) domain size = ( 9,24,24) domain size = ( 9, 9,24) bi-direction force method, domain size = (24,24,18) domain size = (24,24,24) domain size = ( 9,24,24) domain size = ( 9, 9,24) bi-direction force method, domain size = (24,24,18) viscosity error(%) number of sample number of sample Figure 4.32: Comparison of different domain size and bi-direction force method employed, all methods are simulated with cut-off radius of domain size = (24,24,24) domain size = (24,24,24) with inner linked cells domain size = ( 9,24,24) domain size = ( 9,24,24) with inner linked cells domain size = ( 9, 9,24) domain size = ( 9, 9,24) with inner linked cells viscosity domain size = (24,24,24) domain size = (24,24,24) with inner linked cells domain size = ( 9,24,24) domain size = ( 9,24,24) with inner linked cells domain size = ( 9, 9,24) domain size = ( 9, 9,24) with inner linked cells number of sample error(%) number of sample Figure 4.33: The comparison of the whole domain sampling and the inner linked cell sampling for different numbers of samples. 2.0 sample the whole domain only sample the inner linked cells 20 sample the whole domain only sample the inner linked cells viscosity error(%) number of molecule to simulation number of molecule to simulation Figure 4.34: Comparisons of whole domain sampling and inner linked cell sampling with different numbers of molecules for samples. 36

47 4.2 3D Environment samples samples samples samples samples samples viscosity 2.0 error(%) cutoff radius cutoff radius Figure 4.35: Comparisons using different cut-off radii samples samples samples samples samples samples Simulation Time (hour) Simulation Time (hour) number of molecule to simulation cutoff radius Figure 4.36: Simulation time using different numbers of molecules and simulation time for different sizes of the cut-off radius. 37

48 4 Results of Simulation and 9.7%. Concerning time reduction, the domain size of (x, y, z) = (24, 24, 24) required more than 26 hours to reach equilibrium, but required about 6 hours for the reduced size system. Fig shows the results using a smaller cut-off radius of 1.5, which is half of the original value. These results obtain a deviation from the of about 15.0%, and the error in the viscosity is about 17.3% using velocity samples. Fig represents the results using a cut-off radius of 1.0. The deviation is 36.5% and the error in the viscosity is 58.6% for samples. For better comparison, Fig presents the viscosities and errors derived from the different strategies. Fig shows the viscosities and errors derived from the different sampling cells where dotted lines refer to samples obtained using inner linked cells. Fig demonstrates the effect of the number of molecules for a velocity sampling size of Fig indicates the influence of the cut-off radius. Fig reveals not only the relationship between the simulation time and the number of molecules, but also the relationship between the simulation time and the size of the cut-off radius. The complete results are given in Tab. 4.3 to Tab The first column represents the average viscosity from the simulation. The second column is the maximum velocity, which represents the peak of the parabolas given in Fig. 4.5 to Fig The third column shows the error rate computed from Eq The equilibration time given in the fourth column indicates the time of equilibration over which the external force was applied. The simulation time represents the elapsed time for completely finishing velocity sampling. The units for the equilibrium time and the simulation time are both seconds; however, for clarity, other units are provided in parentheses. 38

What is Classical Molecular Dynamics?

What is Classical Molecular Dynamics? What is Classical Molecular Dynamics? Simulation of explicit particles (atoms, ions,... ) Particles interact via relatively simple analytical potential functions Newton s equations of motion are integrated

More information

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

MD Thermodynamics. Lecture 12 3/26/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky MD Thermodynamics Lecture 1 3/6/18 1 Molecular dynamics The force depends on positions only (not velocities) Total energy is conserved (micro canonical evolution) Newton s equations of motion (second order

More information

Scientific Computing II

Scientific Computing II Scientific Computing II Molecular Dynamics Simulation Michael Bader SCCS Summer Term 2015 Molecular Dynamics Simulation, Summer Term 2015 1 Continuum Mechanics for Fluid Mechanics? Molecular Dynamics the

More information

Introduction to molecular dynamics

Introduction to molecular dynamics 1 Introduction to molecular dynamics Yves Lansac Université François Rabelais, Tours, France Visiting MSE, GIST for the summer Molecular Simulation 2 Molecular simulation is a computational experiment.

More information

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

Introduction to Simulation - Lectures 17, 18. Molecular Dynamics. Nicolas Hadjiconstantinou Introduction to Simulation - Lectures 17, 18 Molecular Dynamics Nicolas Hadjiconstantinou Molecular Dynamics Molecular dynamics is a technique for computing the equilibrium and non-equilibrium properties

More information

A Nobel Prize for Molecular Dynamics and QM/MM What is Classical Molecular Dynamics? Simulation of explicit particles (atoms, ions,... ) Particles interact via relatively simple analytical potential

More information

The dynamics of small particles whose size is roughly 1 µmt or. smaller, in a fluid at room temperature, is extremely erratic, and is

The dynamics of small particles whose size is roughly 1 µmt or. smaller, in a fluid at room temperature, is extremely erratic, and is 1 I. BROWNIAN MOTION The dynamics of small particles whose size is roughly 1 µmt or smaller, in a fluid at room temperature, is extremely erratic, and is called Brownian motion. The velocity of such particles

More information

Rate of Heating and Cooling

Rate of Heating and Cooling Rate of Heating and Cooling 35 T [ o C] Example: Heating and cooling of Water E 30 Cooling S 25 Heating exponential decay 20 0 100 200 300 400 t [sec] Newton s Law of Cooling T S > T E : System S cools

More information

Molecular Dynamics Simulation Study of Transport Properties of Diatomic Gases

Molecular Dynamics Simulation Study of Transport Properties of Diatomic Gases MD Simulation of Diatomic Gases Bull. Korean Chem. Soc. 14, Vol. 35, No. 1 357 http://dx.doi.org/1.51/bkcs.14.35.1.357 Molecular Dynamics Simulation Study of Transport Properties of Diatomic Gases Song

More information

Stochastic Particle Methods for Rarefied Gases

Stochastic Particle Methods for Rarefied Gases CCES Seminar WS 2/3 Stochastic Particle Methods for Rarefied Gases Julian Köllermeier RWTH Aachen University Supervisor: Prof. Dr. Manuel Torrilhon Center for Computational Engineering Science Mathematics

More information

Ideal Gas Behavior. NC State University

Ideal Gas Behavior. NC State University Chemistry 331 Lecture 6 Ideal Gas Behavior NC State University Macroscopic variables P, T Pressure is a force per unit area (P= F/A) The force arises from the change in momentum as particles hit an object

More information

Javier Junquera. Statistical mechanics

Javier Junquera. Statistical mechanics Javier Junquera Statistical mechanics From the microscopic to the macroscopic level: the realm of statistical mechanics Computer simulations Thermodynamic state Generates information at the microscopic

More information

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

Understanding Molecular Simulation 2009 Monte Carlo and Molecular Dynamics in different ensembles. Srikanth Sastry JNCASR August 20, 21 2009 Understanding Molecular Simulation 2009 Monte Carlo and Molecular Dynamics in different ensembles Srikanth Sastry Jawaharlal Nehru Centre for Advanced Scientific Research, Bangalore

More information

Molecular Dynamics Simulations

Molecular Dynamics Simulations Molecular Dynamics Simulations Dr. Kasra Momeni www.knanosys.com Outline Long-range Interactions Ewald Sum Fast Multipole Method Spherically Truncated Coulombic Potential Speeding up Calculations SPaSM

More information

An alternative approach to dissipative particle dynamics

An alternative approach to dissipative particle dynamics EUROPHYSICS LETTERS 15 July 1999 Europhys. Lett., 47 (2), pp. 145-151 (1999) An alternative approach to dissipative particle dynamics C. P. Lowe Computational Physics, Delft University of Technology Lorentzweg

More information

CE 530 Molecular Simulation

CE 530 Molecular Simulation CE 530 Molecular Simulation Lecture Molecular Dynamics Simulation David A. Kofke Department of Chemical Engineering SUNY Buffalo kofke@eng.buffalo.edu MD of hard disks intuitive Review and Preview collision

More information

Molecular Dynamics 9/6/16

Molecular Dynamics 9/6/16 Molecular Dynamics What to choose in an integrator The Verlet algorithm Boundary Conditions in Space and time Reading Assignment: Lesar Chpt 6, F&S Chpt 4 1 The Molecular Dynamics (MD) method for classical

More information

Molecular Dynamics Simulation of a Nanoconfined Water Film

Molecular Dynamics Simulation of a Nanoconfined Water Film Molecular Dynamics Simulation of a Nanoconfined Water Film Kyle Lindquist, Shu-Han Chao May 7, 2013 1 Introduction The behavior of water confined in nano-scale environment is of interest in many applications.

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

Structuring of hydrophobic and hydrophilic polymers at interfaces Stephen Donaldson ChE 210D Final Project Abstract

Structuring of hydrophobic and hydrophilic polymers at interfaces Stephen Donaldson ChE 210D Final Project Abstract Structuring of hydrophobic and hydrophilic polymers at interfaces Stephen Donaldson ChE 210D Final Project Abstract In this work, a simplified Lennard-Jones (LJ) sphere model is used to simulate the aggregation,

More information

CHAPTER V. Brownian motion. V.1 Langevin dynamics

CHAPTER V. Brownian motion. V.1 Langevin dynamics CHAPTER V Brownian motion In this chapter, we study the very general paradigm provided by Brownian motion. Originally, this motion is that a heavy particle, called Brownian particle, immersed in a fluid

More information

Introduction Statistical Thermodynamics. Monday, January 6, 14

Introduction Statistical Thermodynamics. Monday, January 6, 14 Introduction Statistical Thermodynamics 1 Molecular Simulations Molecular dynamics: solve equations of motion Monte Carlo: importance sampling r 1 r 2 r n MD MC r 1 r 2 2 r n 2 3 3 4 4 Questions How can

More information

Heat Transport in Glass-Forming Liquids

Heat Transport in Glass-Forming Liquids Heat Transport in Glass-Forming Liquids by VINAY VAIBHAV The Institute of Mathematical Sciences CIT Campus, Taramani, Chennai 600 113, India. A thesis submitted in partial fulfillment of requirements for

More information

1.3 Molecular Level Presentation

1.3 Molecular Level Presentation 1.3.1 Introduction A molecule is the smallest chemical unit of a substance that is capable of stable, independent existence. Not all substances are composed of molecules. Some substances are composed of

More information

Bioengineering 215. An Introduction to Molecular Dynamics for Biomolecules

Bioengineering 215. An Introduction to Molecular Dynamics for Biomolecules Bioengineering 215 An Introduction to Molecular Dynamics for Biomolecules David Parker May 18, 2007 ntroduction A principal tool to study biological molecules is molecular dynamics simulations (MD). MD

More information

Computer simulation methods (1) Dr. Vania Calandrini

Computer simulation methods (1) Dr. Vania Calandrini Computer simulation methods (1) Dr. Vania Calandrini Why computational methods To understand and predict the properties of complex systems (many degrees of freedom): liquids, solids, adsorption of molecules

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

Molecular Dynamics. Timothy O Sullivan Supervised by Naida Lacevic & John Sader The University of Melbourne

Molecular Dynamics. Timothy O Sullivan Supervised by Naida Lacevic & John Sader The University of Melbourne Molecular Dynamics Timothy O Sullivan Supervised by Naida Lacevic & John Sader The University of Melbourne 1 1 Introduction Molecular Dynamics (MD) is a method of simulating systems of nanoscale volumes,

More information

Energy and Forces in DFT

Energy and Forces in DFT Energy and Forces in DFT Total Energy as a function of nuclear positions {R} E tot ({R}) = E DF T ({R}) + E II ({R}) (1) where E DF T ({R}) = DFT energy calculated for the ground-state density charge-density

More information

Statistical Physics. Problem Set 4: Kinetic Theory

Statistical Physics. Problem Set 4: Kinetic Theory Statistical Physics xford hysics Second year physics course Dr A. A. Schekochihin and Prof. A. Boothroyd (with thanks to Prof. S. J. Blundell) Problem Set 4: Kinetic Theory PROBLEM SET 4: Collisions and

More information

Molecular dynamics simulation. CS/CME/BioE/Biophys/BMI 279 Oct. 5 and 10, 2017 Ron Dror

Molecular dynamics simulation. CS/CME/BioE/Biophys/BMI 279 Oct. 5 and 10, 2017 Ron Dror Molecular dynamics simulation CS/CME/BioE/Biophys/BMI 279 Oct. 5 and 10, 2017 Ron Dror 1 Outline Molecular dynamics (MD): The basic idea Equations of motion Key properties of MD simulations Sample applications

More information

Gear methods I + 1/18

Gear methods I + 1/18 Gear methods I + 1/18 Predictor-corrector type: knowledge of history is used to predict an approximate solution, which is made more accurate in the following step we do not want (otherwise good) methods

More information

CE 530 Molecular Simulation

CE 530 Molecular Simulation 1 CE 530 Molecular Simulation Lecture 1 David A. Kofke Department of Chemical Engineering SUNY Buffalo kofke@eng.buffalo.edu 2 Time/s Multi-Scale Modeling Based on SDSC Blue Horizon (SP3) 1.728 Tflops

More information

Introduction to model potential Molecular Dynamics A3hourcourseatICTP

Introduction to model potential Molecular Dynamics A3hourcourseatICTP Introduction to model potential Molecular Dynamics A3hourcourseatICTP Alessandro Mattoni 1 1 Istituto Officina dei Materiali CNR-IOM Unità di Cagliari SLACS ICTP School on numerical methods for energy,

More information

MOLECULAR DYNAMIC SIMULATION OF WATER VAPOR INTERACTION WITH VARIOUS TYPES OF PORES USING HYBRID COMPUTING STRUCTURES

MOLECULAR DYNAMIC SIMULATION OF WATER VAPOR INTERACTION WITH VARIOUS TYPES OF PORES USING HYBRID COMPUTING STRUCTURES MOLECULAR DYNAMIC SIMULATION OF WATER VAPOR INTERACTION WITH VARIOUS TYPES OF PORES USING HYBRID COMPUTING STRUCTURES V.V. Korenkov 1,3, a, E.G. Nikonov 1, b, M. Popovičová 2, с 1 Joint Institute for Nuclear

More information

Computational Physics

Computational Physics Computational Physics Molecular Dynamics Simulations E. Carlon, M. Laleman and S. Nomidis Academic year 015/016 Contents 1 Introduction 3 Integration schemes 4.1 On the symplectic nature of the Velocity

More information

Temperature and Pressure Controls

Temperature and Pressure Controls Ensembles Temperature and Pressure Controls 1. (E, V, N) microcanonical (constant energy) 2. (T, V, N) canonical, constant volume 3. (T, P N) constant pressure 4. (T, V, µ) grand canonical #2, 3 or 4 are

More information

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t)

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t) IV. DIFFERENTIAL RELATIONS FOR A FLUID PARTICLE This chapter presents the development and application of the basic differential equations of fluid motion. Simplifications in the general equations and common

More information

Metropolis, 2D Ising model

Metropolis, 2D Ising model Metropolis, 2D Ising model You can get visual understanding from the java applets available, like: http://physics.ucsc.edu/~peter/ising/ising.html Average value of spin is magnetization. Abs of this as

More information

WATER PERMEATION THROUGH GRAPHENE NANOSLIT BY MOLECULAR DYNAMICS SIMULATION

WATER PERMEATION THROUGH GRAPHENE NANOSLIT BY MOLECULAR DYNAMICS SIMULATION WATER PERMEATION THROUGH GRAPHENE NANOSLIT BY MOLECULAR DYNAMICS SIMULATION Taro Yamada 1 and Ryosuke Matsuzaki 2 1 Department of Mechanical Engineering, Tokyo University of Science, 2641 Yamazaki, Noda,

More information

Chapter 4 Molecular Dynamics and Other Dynamics

Chapter 4 Molecular Dynamics and Other Dynamics Chapter 4 Molecular Dynamics and Other Dynamics Molecular dynamics is a method in which the motion of each individual atom or molecule is computed according to Newton s second law. It usually involves

More information

Intermolecular Forces and Monte-Carlo Integration 열역학특수연구

Intermolecular Forces and Monte-Carlo Integration 열역학특수연구 Intermolecular Forces and Monte-Carlo Integration 열역학특수연구 2003.3.28 Source of the lecture note. J.M.Prausnitz and others, Molecular Thermodynamics of Fluid Phase Equiliria Atkins, Physical Chemistry Lecture

More information

This semester. Books

This semester. Books Models mostly proteins from detailed to more abstract models Some simulation methods This semester Books None necessary for my group and Prof Rarey Molecular Modelling: Principles and Applications Leach,

More information

Summary We develop an unconditionally stable explicit particle CFD scheme: Boltzmann Particle Hydrodynamics (BPH)

Summary We develop an unconditionally stable explicit particle CFD scheme: Boltzmann Particle Hydrodynamics (BPH) Summary Steps in BPH Space is divided into Cartesian cells Finite number of particles ~10 6-10 7 Particles fly freely between t n and t n+1 Mass, momentum and total energy are conserved Relax into a (LTE)

More information

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

Introduction to Computer Simulations of Soft Matter Methodologies and Applications Boulder July, 19-20, 2012 Introduction to Computer Simulations of Soft Matter Methodologies and Applications Boulder July, 19-20, 2012 K. Kremer Max Planck Institute for Polymer Research, Mainz Overview Simulations, general considerations

More information

FORCE ENERGY. only if F = F(r). 1 Nano-scale (10 9 m) 2 Nano to Micro-scale (10 6 m) 3 Nano to Meso-scale (10 3 m)

FORCE ENERGY. only if F = F(r). 1 Nano-scale (10 9 m) 2 Nano to Micro-scale (10 6 m) 3 Nano to Meso-scale (10 3 m) What is the force? CEE 618 Scientific Parallel Computing (Lecture 12) Dissipative Hydrodynamics (DHD) Albert S. Kim Department of Civil and Environmental Engineering University of Hawai i at Manoa 2540

More information

UNIVERSITY OF OSLO FACULTY OF MATHEMATICS AND NATURAL SCIENCES

UNIVERSITY OF OSLO FACULTY OF MATHEMATICS AND NATURAL SCIENCES UNIVERSITY OF OSLO FCULTY OF MTHEMTICS ND NTURL SCIENCES Exam in: FYS430, Statistical Mechanics Day of exam: Jun.6. 203 Problem :. The relative fluctuations in an extensive quantity, like the energy, depends

More information

Dynamic modelling of morphology development in multiphase latex particle Elena Akhmatskaya (BCAM) and Jose M. Asua (POLYMAT) June

Dynamic modelling of morphology development in multiphase latex particle Elena Akhmatskaya (BCAM) and Jose M. Asua (POLYMAT) June Dynamic modelling of morphology development in multiphase latex particle Elena Akhmatskaya (BCAM) and Jose M. Asua (POLYMAT) June 7 2012 Publications (background and output) J.M. Asua, E. Akhmatskaya Dynamic

More information

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

Ab initio molecular dynamics. Simone Piccinin CNR-IOM DEMOCRITOS Trieste, Italy. Bangalore, 04 September 2014 Ab initio molecular dynamics Simone Piccinin CNR-IOM DEMOCRITOS Trieste, Italy Bangalore, 04 September 2014 What is MD? 1) Liquid 4) Dye/TiO2/electrolyte 2) Liquids 3) Solvated protein 5) Solid to liquid

More information

Modeling of Micro-Fluidics by a Dissipative Particle Dynamics Method. Justyna Czerwinska

Modeling of Micro-Fluidics by a Dissipative Particle Dynamics Method. Justyna Czerwinska Modeling of Micro-Fluidics by a Dissipative Particle Dynamics Method Justyna Czerwinska Scales and Physical Models years Time hours Engineering Design Limit Process Design minutes Continious Mechanics

More information

From Molecular Dynamics to hydrodynamics a novel Galilean invariant thermostat

From Molecular Dynamics to hydrodynamics a novel Galilean invariant thermostat To appear in: Journal of Chemical Physics, 08 APR 005 From Molecular Dynamics to hydrodynamics a novel Galilean invariant thermostat Simeon D. Stoyanov and Robert D. Groot Unilever Research Vlaardingen,

More information

Analysis of the simulation

Analysis of the simulation Analysis of the simulation Marcus Elstner and Tomáš Kubař January 7, 2014 Thermodynamic properties time averages of thermodynamic quantites correspond to ensemble averages (ergodic theorem) some quantities

More information

What s important: viscosity Poiseuille's law Stokes' law Demo: dissipation in flow through a tube

What s important: viscosity Poiseuille's law Stokes' law Demo: dissipation in flow through a tube PHYS 101 Lecture 29x - Viscosity 29x - 1 Lecture 29x Viscosity (extended version) What s important: viscosity Poiseuille's law Stokes' law Demo: dissipation in flow through a tube Viscosity We introduced

More information

Scientific Computing II

Scientific Computing II Technische Universität München ST 008 Institut für Informatik Dr. Miriam Mehl Scientific Computing II Final Exam, July, 008 Iterative Solvers (3 pts + 4 extra pts, 60 min) a) Steepest Descent and Conjugate

More information

APMA 2811T. By Zhen Li. Today s topic: Lecture 2: Theoretical foundation and parameterization. Sep. 15, 2016

APMA 2811T. By Zhen Li. Today s topic: Lecture 2: Theoretical foundation and parameterization. Sep. 15, 2016 Today s topic: APMA 2811T Dissipative Particle Dynamics Instructor: Professor George Karniadakis Location: 170 Hope Street, Room 118 Time: Thursday 12:00pm 2:00pm Dissipative Particle Dynamics: Foundation,

More information

arxiv: v1 [cond-mat.stat-mech] 7 Mar 2019

arxiv: v1 [cond-mat.stat-mech] 7 Mar 2019 Langevin thermostat for robust configurational and kinetic sampling Oded Farago, Department of Chemistry, University of Cambridge, Lensfield Road, Cambridge CB EW, United Kingdom Department of Biomedical

More information

Brownian motion and the Central Limit Theorem

Brownian motion and the Central Limit Theorem Brownian motion and the Central Limit Theorem Amir Bar January 4, 3 Based on Shang-Keng Ma, Statistical Mechanics, sections.,.7 and the course s notes section 6. Introduction In this tutorial we shall

More information

Advanced Topics in Equilibrium Statistical Mechanics

Advanced Topics in Equilibrium Statistical Mechanics Advanced Topics in Equilibrium Statistical Mechanics Glenn Fredrickson 2. Classical Fluids A. Coarse-graining and the classical limit For concreteness, let s now focus on a fluid phase of a simple monatomic

More information

Supplementary Information for: Controlling Cellular Uptake of Nanoparticles with ph-sensitive Polymers

Supplementary Information for: Controlling Cellular Uptake of Nanoparticles with ph-sensitive Polymers Supplementary Information for: Controlling Cellular Uptake of Nanoparticles with ph-sensitive Polymers Hong-ming Ding 1 & Yu-qiang Ma 1,2, 1 National Laboratory of Solid State Microstructures and Department

More information

Estimating Accuracy in Classical Molecular Simulation

Estimating Accuracy in Classical Molecular Simulation Estimating Accuracy in Classical Molecular Simulation University of Illinois Urbana-Champaign Department of Computer Science Institute for Mathematics and its Applications July 2007 Acknowledgements Ben

More information

Advanced sampling. fluids of strongly orientation-dependent interactions (e.g., dipoles, hydrogen bonds)

Advanced sampling. fluids of strongly orientation-dependent interactions (e.g., dipoles, hydrogen bonds) Advanced sampling ChE210D Today's lecture: methods for facilitating equilibration and sampling in complex, frustrated, or slow-evolving systems Difficult-to-simulate systems Practically speaking, one is

More information

Molecular Dynamics Simulation of Argon

Molecular Dynamics Simulation of Argon Molecular Dynamics Simulation of Argon The fundamental work on this problem was done by A. Rahman, Phys. Rev. 136, A405 (1964). It was extended in many important ways by L. Verlet, Phys. Rev. 159, 98 (1967),

More information

Review of Fluid Mechanics

Review of Fluid Mechanics Chapter 3 Review of Fluid Mechanics 3.1 Units and Basic Definitions Newton s Second law forms the basis of all units of measurement. For a particle of mass m subjected to a resultant force F the law may

More information

A path integral approach to the Langevin equation

A path integral approach to the Langevin equation A path integral approach to the Langevin equation - Ashok Das Reference: A path integral approach to the Langevin equation, A. Das, S. Panda and J. R. L. Santos, arxiv:1411.0256 (to be published in Int.

More information

Fluid Mechanics Theory I

Fluid Mechanics Theory I Fluid Mechanics Theory I Last Class: 1. Introduction 2. MicroTAS or Lab on a Chip 3. Microfluidics Length Scale 4. Fundamentals 5. Different Aspects of Microfluidcs Today s Contents: 1. Introduction to

More information

Introduction to Marine Hydrodynamics

Introduction to Marine Hydrodynamics 1896 1920 1987 2006 Introduction to Marine Hydrodynamics (NA235) Department of Naval Architecture and Ocean Engineering School of Naval Architecture, Ocean & Civil Engineering First Assignment The first

More information

University of Washington Department of Chemistry Chemistry 453 Winter Quarter 2013

University of Washington Department of Chemistry Chemistry 453 Winter Quarter 2013 Lecture 1 3/13/13 University of Washington Department of Chemistry Chemistry 53 Winter Quarter 013 A. Definition of Viscosity Viscosity refers to the resistance of fluids to flow. Consider a flowing liquid

More information

Ab initio molecular dynamics and nuclear quantum effects

Ab initio molecular dynamics and nuclear quantum effects Ab initio molecular dynamics and nuclear quantum effects Luca M. Ghiringhelli Fritz Haber Institute Hands on workshop density functional theory and beyond: First principles simulations of molecules and

More information

Temperature and Pressure Controls

Temperature and Pressure Controls Ensembles Temperature and Pressure Controls 1. (E, V, N) microcanonical (constant energy) 2. (T, V, N) canonical, constant volume 3. (T, P N) constant pressure 4. (T, V, µ) grand canonical #2, 3 or 4 are

More information

A Study of the Thermal Properties of a One. Dimensional Lennard-Jones System

A Study of the Thermal Properties of a One. Dimensional Lennard-Jones System A Study of the Thermal Properties of a One Dimensional Lennard-Jones System Abstract In this study, the behavior of a one dimensional (1D) Lennard-Jones (LJ) system is simulated. As part of this research,

More information

How DLS Works: Interference of Light

How DLS Works: Interference of Light Static light scattering vs. Dynamic light scattering Static light scattering measures time-average intensities (mean square fluctuations) molecular weight radius of gyration second virial coefficient Dynamic

More information

Dynamic force matching: Construction of dynamic coarse-grained models with realistic short time dynamics and accurate long time dynamics

Dynamic force matching: Construction of dynamic coarse-grained models with realistic short time dynamics and accurate long time dynamics for resubmission Dynamic force matching: Construction of dynamic coarse-grained models with realistic short time dynamics and accurate long time dynamics Aram Davtyan, 1 Gregory A. Voth, 1 2, a) and Hans

More information

CEE 618 Scientific Parallel Computing (Lecture 12)

CEE 618 Scientific Parallel Computing (Lecture 12) 1 / 26 CEE 618 Scientific Parallel Computing (Lecture 12) Dissipative Hydrodynamics (DHD) Albert S. Kim Department of Civil and Environmental Engineering University of Hawai i at Manoa 2540 Dole Street,

More information

Pedestrian traffic models

Pedestrian traffic models December 1, 2014 Table of contents 1 2 3 to Pedestrian Dynamics Pedestrian dynamics two-dimensional nature should take into account interactions with other individuals that might cross walking path interactions

More information

For info and ordering all the 4 versions / languages of this book please visit: http://trl.lab.uic.edu/pon Contents Preface vii Chapter 1 Advances in Atomic and Molecular Nanotechnology Introduction 1

More information

Molecular Dynamics Simulations. Dr. Noelia Faginas Lago Dipartimento di Chimica,Biologia e Biotecnologie Università di Perugia

Molecular Dynamics Simulations. Dr. Noelia Faginas Lago Dipartimento di Chimica,Biologia e Biotecnologie Università di Perugia Molecular Dynamics Simulations Dr. Noelia Faginas Lago Dipartimento di Chimica,Biologia e Biotecnologie Università di Perugia 1 An Introduction to Molecular Dynamics Simulations Macroscopic properties

More information

2 Equations of Motion

2 Equations of Motion 2 Equations of Motion system. In this section, we will derive the six full equations of motion in a non-rotating, Cartesian coordinate 2.1 Six equations of motion (non-rotating, Cartesian coordinates)

More information

Scientific Computing II

Scientific Computing II Scientific Computing II Molecular Dynamics Numerics Michael Bader SCCS Technical University of Munich Summer 018 Recall: Molecular Dynamics System of ODEs resulting force acting on a molecule: F i = j

More information

The Truth about diffusion (in liquids)

The Truth about diffusion (in liquids) The Truth about diffusion (in liquids) Aleksandar Donev Courant Institute, New York University & Eric Vanden-Eijnden, Courant In honor of Berni Julian Alder LLNL, August 20th 2015 A. Donev (CIMS) Diffusion

More information

Introduction to Computational Materials Science

Introduction to Computational Materials Science Introduction to Computational Materials Science Fundamentals to Applications RICHARD LESAR lowa State University.CAMBRIDGE ::: UNIVERSITY PRESS CONTENTS Preface 1 Introduction to materials modeling and

More information

Statistical Physics. Solutions Sheet 11.

Statistical Physics. Solutions Sheet 11. Statistical Physics. Solutions Sheet. Exercise. HS 0 Prof. Manfred Sigrist Condensation and crystallization in the lattice gas model. The lattice gas model is obtained by dividing the volume V into microscopic

More information

MD simulation of methane in nanochannels

MD simulation of methane in nanochannels MD simulation of methane in nanochannels COCIM, Arica, Chile M. Horsch, M. Heitzig, and J. Vrabec University of Stuttgart November 6, 2008 Scope and structure Molecular model for graphite and the fluid-wall

More information

Langevin Methods. Burkhard Dünweg Max Planck Institute for Polymer Research Ackermannweg 10 D Mainz Germany

Langevin Methods. Burkhard Dünweg Max Planck Institute for Polymer Research Ackermannweg 10 D Mainz Germany Langevin Methods Burkhard Dünweg Max Planck Institute for Polymer Research Ackermannweg 1 D 55128 Mainz Germany Motivation Original idea: Fast and slow degrees of freedom Example: Brownian motion Replace

More information

Entropy generation and transport

Entropy generation and transport Chapter 7 Entropy generation and transport 7.1 Convective form of the Gibbs equation In this chapter we will address two questions. 1) How is Gibbs equation related to the energy conservation equation?

More information

8.6 Drag Forces in Fluids

8.6 Drag Forces in Fluids 86 Drag Forces in Fluids When a solid object moves through a fluid it will experience a resistive force, called the drag force, opposing its motion The fluid may be a liquid or a gas This force is a very

More information

Molecular Clustering and Velocity Increase in Converging-Diverging Nozzle in MD Simulation

Molecular Clustering and Velocity Increase in Converging-Diverging Nozzle in MD Simulation Molecular Clustering and Velocity Increase in Converging-Diverging Nozzle in MD Simulation Jeoungsu Na 1, Jaehawn Lee 2, Changil Hong 2, Suhee Kim 1 R&D Department of NaJen, Co. LTD, Korea 2 Dept. of Computer

More information

Electric Force and Field Chapter Questions

Electric Force and Field Chapter Questions Electric Force and Field Chapter Questions 1. What happens to a plastic rod when it is rubbed with a piece of animal fur? What happens to the piece of fur? 2. How many types of electric charge are there?

More information

2D Clausius Clapeyron equation

2D Clausius Clapeyron equation 2D Clausius Clapeyron equation 1/14 Aim: Verify the Clausius Clapeyron equation by simulations of a 2D model of matter Model: 8-4 type potential ( Lennard-Jones in 2D) u(r) = 1 r 8 1 r 4 Hard attractive

More information

Molecular Dynamics. A very brief introduction

Molecular Dynamics. A very brief introduction Molecular Dynamics A very brief introduction Sander Pronk Dept. of Theoretical Physics KTH Royal Institute of Technology & Science For Life Laboratory Stockholm, Sweden Why computer simulations? Two primary

More information

Atoms, electrons and Solids

Atoms, electrons and Solids Atoms, electrons and Solids Shell model of an atom negative electron orbiting a positive nucleus QM tells that to minimize total energy the electrons fill up shells. Each orbit in a shell has a specific

More information

Exercise 2: Solvating the Structure Before you continue, follow these steps: Setting up Periodic Boundary Conditions

Exercise 2: Solvating the Structure Before you continue, follow these steps: Setting up Periodic Boundary Conditions Exercise 2: Solvating the Structure HyperChem lets you place a molecular system in a periodic box of water molecules to simulate behavior in aqueous solution, as in a biological system. In this exercise,

More information

Dissipative particle dynamics: Bridging the gap between atomistic and mesoscopic simulation

Dissipative particle dynamics: Bridging the gap between atomistic and mesoscopic simulation Dissipative particle dynamics: Bridging the gap between atomistic and mesoscopic simulation Robert D. Groot and Patrick B. Warren Unilever Research Port Sunlight Laboratory, Quarry Road East, Bebington,

More information

Time Evolution of Speed

Time Evolution of Speed ENERGY & MOMENTUM Newton's 2 nd Law: Time Evolution of Speed Describes how force affects velocity of the CM How do forces affect speed of the CM? Depends on relative direction of force and velocity: F

More information

Simulation of molecular systems by molecular dynamics

Simulation of molecular systems by molecular dynamics Simulation of molecular systems by molecular dynamics Yohann Moreau yohann.moreau@ujf-grenoble.fr November 26, 2015 Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, 2015 1 / 35 Introduction

More information

Lattice Boltzmann Simulation of One Particle Migrating in a Pulsating Flow in Microvessel

Lattice Boltzmann Simulation of One Particle Migrating in a Pulsating Flow in Microvessel Commun. Theor. Phys. 56 (2011) 756 760 Vol. 56, No. 4, October 15, 2011 Lattice Boltzmann Simulation of One Particle Migrating in a Pulsating Flow in Microvessel QIU Bing ( ), 1, TAN Hui-Li ( Û), 2 and

More information

Supporting information

Supporting information Electronic Supplementary Material ESI for Physical Chemistry Chemical Physics. This journal is the Owner Societies 2018 Supporting information Understanding three-body contributions to coarse-grained force

More information

EXTENDED FREE SURFACE FLOW MODEL BASED ON THE LATTICE BOLTZMANN APPROACH

EXTENDED FREE SURFACE FLOW MODEL BASED ON THE LATTICE BOLTZMANN APPROACH METALLURGY AND FOUNDRY ENGINEERING Vol. 36, 2010, No. 2 Micha³ Szucki*, Józef S. Suchy***, Pawe³ ak*, Janusz Lelito**, Beata Gracz* EXTENDED FREE SURFACE FLOW MODEL BASED ON THE LATTICE BOLTZMANN APPROACH

More information

Imperfect Gases. NC State University

Imperfect Gases. NC State University Chemistry 431 Lecture 3 Imperfect Gases NC State University The Compression Factor One way to represent the relationship between ideal and real gases is to plot the deviation from ideality as the gas is

More information

G : Statistical Mechanics

G : Statistical Mechanics G25.2651: Statistical Mechanics Notes for Lecture 15 Consider Hamilton s equations in the form I. CLASSICAL LINEAR RESPONSE THEORY q i = H p i ṗ i = H q i We noted early in the course that an ensemble

More information

Statistical methods in atomistic computer simulations

Statistical methods in atomistic computer simulations Statistical methods in atomistic computer simulations Prof. Michele Ceriotti, michele.ceriotti@epfl.ch This course gives an overview of simulation techniques that are useful for the computational modeling

More information