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

Size: px
Start display at page:

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

Transcription

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

2 1 Introduction Molecular Dynamics (MD) is a method of simulating systems of nanoscale volumes, in ways that are normally unavailable via analytic or statistical methods. Using MD simulations, this unseen world can be probed, allowing for real-time calculations of a physical, molecular system. From these calculations, various properties of the system can be inferred. This gives information of changing behaviours over time and indicates the various effects of different boundary conditions. This report will investigate a ground up approach towards MD simulations, which will then be verified via thermodynamic calculations performed on the system. The algorithm developed will then be used to investigate the effects of varying boundary conditions on a simulated solution to the Navier-Stokes equation; Couette Flow. 2 Principles To simulate the dynamics of a system, one must first have some idea of how the system will behave. This can easily be determined via the system s characteristic equations of motion and an associated potential. For this report, we will assume a system comprising of N particles, obeying Newton s Equations: F i = m i a i (1) Where F i is the force on the i-th particle, and a i, m i and r i are the acceleration, mass and position of the i-th particle respectively. First and foremost, the force on each particle must be calculated. This can be done via the following relation: (2) (3) Where U ij is the potential between particles i and j, and r ij is their separation. With knowledge of (1), (2) and (3), a potential is all that is required to simulate the system. The potential to be used in this report will be the Lennard-Jones potential: 2

3 Figure 1: The Lennard-Jones Potential. Image credit: By Olaf Lenz, Rainald62 [GFDL ( CC-BY-SA-3.0 ( or CC BY-SA ( via Wikimedia Commons The Lennard-Jones potential is a reasonably accurate model of the interatomic potential. The second term represents the attractive forces between atoms, ie dispersion forces, and the first term represents the repulsive forces due to the Pauli-Exclusion principle. Also note the quantities ε and σ in the equation for the potential. The presence of these quantities suggests some sort of characteristic energy and length scale for the system. 2.1 Scaling The system can now be scaled accordingly: V = V ε (4) r = r σ T = k BT ε (5) (6) t = t σ m ε (7) 3

4 v = v ε m (8) F = Fσ ε P = Pσ3 ε (9) (10) From here the * notation will be dropped for convenience. Any other quantities not listed here will be scaled accordingly. 3 Simulating the System Now that the system has been mathematically quantified, the ODE s need to be solved. The ODE s specifically are N versions of (2), which are all coupled to each other. The standard method would be to use the Runge-Kutta algorithm, however Runge-Kutta exhibits poor long-term energy conservation (Frenkel and Smit, 2001). So a different numerical solving algorithm is required. 3.1 The Verlet Algorithm Instead, the Verlet algorithm is put to use. Its formulation is as follows: Take perturbations of a particle s position forward and backward in time: r(t + t) = r(t) + v(t) t + 1 2! m F(t) t2 + 1 d 3 r(t) 3! dt 3 t 3 + O( t 4 ) (11) r(t t) = r(t) v(t) t + 1 2! m F(t) t2 1 d 3 r(t) 3! dt 3 t 3 + O( t 4 ) (12) By adding (11) and (12) together, the following is obtained: r(t + t) = 2r(t) r(t t) + 1 m F(t) t2 + O( t 4 ) (13) So by calculating the forces on the particles at every time step, their positions can be solved for all time. 4

5 One amendment that must be made to this algorithm is the calculation of velocities. The Verlet algorithm does not care about velocities, so they need to be treated separately as follows: r(t + t) r(t t) v(t + t) = 2 t (14) 3.2 Initial Conditions A square packing of particles was chosen as the initial conditions for the system: Figure 2: Square packing initial conditions. It should be noted however, that the initial conditions don t necessarily matter, as long as there isn t severe overlap of any particles. The initial velocities are also chosen such that the system s initial temperature can match the desired temperature. 3.2 Boundary Conditions Periodic boundary conditions were chosen for this project as they eliminate any effects a physical boundary may have on the system. It also allows for a pseudosimulation of an infinite system. The principles of these boundary conditions are as follows: Imagine the unit-cell (the system to be simulated) at the centre of an infinitely large array of identical image cells: 5

6 Figure 3: Unit cell in an infinite, bulk system. By doing this, any particles that leave the middle cell through the right re-enter through the left and similarly for top and bottom. This gives a system that conserves particle number. The forces on the particles due to the particle images are also calculated. To maintain symmetry and computational simplicity, a cut-off radius is chosen for the potential. This radius will be chosen to be r c = 2.5 for the remainder of the report unless otherwise specified. U(r c ) = 0.016, so the error associated with introducing this cut-off is small enough such that it will not affect the physics of the system. The box width is also chosen to be at least double that of the cut-off radius. By doing so, the particles will only interact with one of each image at most, and more importantly, particles will not be able to interact with their own images. 3.3 Flow Chart The code flow chart has been added to ensure absolute clarity of the project thus far: 6

7 Figure 4: MD code flow-chart. 4 Couette Flow The second aim of the simulation is to simulate an analytic solution to the Navier- Stokes equation: Couette Flow. If we take the Navier Stokes equation: u P + u u = t ρ + ν 2 u (15) Where u is the velocity of the fluid, P is the fluid pressure and ν is the kinematic viscosity. If this equation is then applied to a Couette flow system, ie: Figure 5: Fluid between shearing plates, ie Couette flow. 7

8 And by making the appropriate assumptions, the Navier-Stokes equation reduces to: d 2 u dy 2 = 0 (16) If a no-slip boundary condition is assumed (ie relative velocity between fluid and solid is zero at the fluid-solid interface), the following solution is found: u(y) = U y h (17) So the Navier-stokes solution states that the steady-flow solution to Couette flow is a linear velocity profile, matching the wall velocities at the boundaries (assuming no slip). Now that this solution has been found, it is natural to then check how this solution compares to an MD simulation of the same system. To do this, some additions need to be made to the pre-existing algorithm. It s rather simple and only requires two things. 4.1 The Walls To simulate Couette flow with Molecular Dynamics, the walls need to be added in. The walls will comprise of similar Lennard-Jones particles, like the fluid. However, ε wf, the interaction strength between wall and fluid particles will be varied. It is also assumed that the walls are not affected by this interaction, ie they are completely rigid (a spring potential can be added later, however this not completely necessary and this assumption of rigidity saves a lot of computation time). The walls will also be initialized with a hexagonal packing: Figure 6: Hexagonal Packing of particles. This allows for the most realistic simulation of a solid at very high density, which may be considered at some point in this simulation. The walls will also obey periodic boundary conditions. 4.2 The Thermostat 8

9 The last thing needed to accurately simulate Couette flow is a way to keep the systems temperature constant. This is necessary because the temperature of a physical Couette flow channel stays constant because any kinetic energy added to the system by the walls is constantly being carried downstream to a point of lower energy. However, this doesn t occur in the MD system, due to the periodic boundary conditions. Therefore, any kinetic energy added to the fluid by the moving wall will accumulate. A thermostat is necessary to dissipate this extra heat so that the periodic system can be treated as an infinite, planar channel. There are many ways to do this, with some being better than others. A very quick investigation was conducted into various thermostats to see which one was the most appropriate for the purposes of this report Velocity Rescale A velocity rescale is by far the simplest thermostat to apply. It works by checking a system s temperature, and if it is above or below the desired temperature, the particle velocities are adjusted accordingly. Due to the simple nature of this thermostat, it can be applied in systems of all densities and temperatures. This simplicity comes with a cost however, especially with the Verlet algorithm. Since the Verlet algorithm does not consider velocities, a position rescale must instead be considered. This is extremely risky to do, as it only takes one particle s position to be rescaled too close to that of another particle, and the solver will fail Nose-Hoover Thermostat The Nose-Hoover Thermostat involves adding a friction term to the equations of motion of the particles. However, this thermostat is better suited to a Hamiltonian formulation, as opposed to the Newtonian formulation used in this report. Any resources that were found that did treat the Newtonian formulation with a Nose- Hoover thermostat used different solving algorithms to that of the Verlet Algorithm. Attempts were made to try and resolve the Verlet algorithm with the Nose-Hoover thermostat, however this caused the temperature to oscillate at a fixed frequency instead of being held constant Langevin Thermostat This was the thermostat most commonly found amongst the literature when simulating Couette flow with MD. With some effort, this thermostat did keep the system temperature constant, however the parameters used to achieve this would not work for any other fluid density. Thus any adjustment to the fluid properties meant a complete adjustment of the Langevin thermostat parameters. 9

10 Despite showing great temperature control, the Langevin thermostat showed complete inconvenience when it was used in generality Berendsen Thermostat The Berendsen thermostat is implemented by weakly coupling the system to a heat-bath of the desired temperature. This is done in reality by adding a friction term to the equations of motion, much like the Nose-Hoover thermostat. However it was found that unlike the Nose-Hoover thermostat, the Berendsen thermostat kept temperature constant with no issue when it was coupled with the Verlet algorithm. It was also found to work in complete generality, unlike the Langevin thermostat. No issues of solver failure were ever encountered as long as the Berendsen parameters were given reasonable numbers, unlike the velocity rescale method. However it has been shown that the Berendsen thermostat does not keep the system in the correct thermodynamic ensemble (Hünenburg, 2005). Despite this, the Berendsen thermostat was chosen for this report due to its ability to be applied across a broad array of systems. Any effects this thermostat has on the thermodynamics of MD need further systematic investigation. Since the Berendsen thermostat has been chosen as the thermostat for Couette flow, its equation of motion is specified: d 2 r dt 2 = 1 m {F + 1 2τ [ T 0 T(t) 1] v} (18) Where T 0 is the desired temperature and T(t) is the current temperature. The parameter τ is a relaxation parameter that determines how quickly the system returns to the desired temperature. The Verlet algorithm is then adjusted accordingly. 5 Calculations Various measurements of the system will be made via calculations using the evolving positions of the particles in time. Some will be specified just to ensure that the system is working properly, others will be genuine attempts at understanding the dynamics of the system. 5.1 Energy The first quantity of interest is energy. From these calculations, the systems energy conservation can be confirmed, the temperature can be determined and pressure can start to be calculated. 10

11 5.1.1 Kinetic Energy Kinetic energy is calculated in the usual way: N K = 1 2 v i 2 i=1 (19) That is, a sum over the squares of all particle velocities Potential Energy Imagine each interacting pair of particles as two balls connected by a spring. The sum of the energies in each of these springs is the systems potential, or more explicitly: N 1 N U = U ij (r ij ) i=1 j=i+1 (20) Total Energy The systems total energy is calculated in the usual way: Temperature E = K + U (21) The systems temperature is calculated depending on whether the system is 2- dimensional or 3-dimensional. For 2D: T = K N (22) For 3D: T = 2K 3N (23) 5.2 Pressure The pressure of the system can be calculated in two ways: P = ρt + 1 3V r ij F ij i j<i (23) 11

12 P = ρt ρ2 6 du(r) dr rg(r) dr 0 0 = ρt 2 3 πρ2 dr du(r) r3 g(r) dr (24) (25) Where g(r) is the pair correlation function, a function that describes the overall structure of the fluid. Both methods are equally valid, however (23) is used for convenience. The calculation is not complete however. A correction term must be added due to the presence of the cut-off radius. This is done by using (25). Since the integral from 0 to r c has already been accounted for, the correction term is just the remainder of the integral in (25), ie: P rc = 2 3 πρ2 dr du(r) dr r3 g(r) (26) r c It is then assumed that g(r) = 1 (error associated in doing so is 0.05 at most) (Verlet, 1967), it is found that: Thus, the expression for pressure is: P = ρt + 1 3V P rc = 16πρ 2 ( 2 9r c 9 1 3r c 3 ) (27) i j<i r ij F ij + 16πρ 2 ( 2 9r c 9 1 3r c 3 ) (28) 5.3 Diffusion Another class of properties that are of interest are transport properties of the fluid. Firstly, diffusion is considered. Diffusion is the process by which a fluid will move from a region of high concentration to a region of low concentration. Since there is only one fluid to consider in this simulation, self-diffusion is considered; the process by which individual fluid particles will move throughout their parent fluid. This process can be mathematically quantified via a combination of the continuity equation: Fick s law: c(r, t) t + j(r, t) = 0 (29) j = D c (30) 12

13 And the definition of the mean of a continuous variable, specifically the meansquared displacement: r 2 (t) drc(r, t)r 2 (31) From (29), (30) and (31), it can be derived that: r 2 (t) = 2dD t (32) ie the Diffusion coefficient of a fluid can be found from the gradient of the meansquared displacement versus time graph. The full derivation of (32) can be found in Understanding Molecular Simulation: From Algorithms to Applications by Frenkel and Smit. To calculate the Diffusion coefficient from these calculations, the squared displacement of each particles is recorded and averaged for every time step of the Verlet algorithm. To smooth the data set, this is repeated for every second time step, every third time step etc. 5.3 Viscosity Once a result has been calculated for the Diffusion coefficient for the LJ fluid, that result can then immediately be used to calculate the Viscosity of the fluid. Viscosity is a measure of a fluids resistance to a shear or tensile stress. Via use of the Stokes- Einstein relation: Dμ = k BT 6πr H (33) Where μ is the fluid viscosity and r H is the hydrodynamic radius, which will be taken to be the molecular radius in the case of Argon.The viscosity can then be immediately be solved for. 5.4 Velocity Profiles Once Couette flow has been successfully simulated, the continuum approximation will be compared with the velocity profile obtained from the MD simulation. To obtain these velocity profiles, the Couette flow channel is divided into bins and the x-velocity of the particles in each bin is summed. These sums are then divided by the number of particles in each bin. These results can then be plotted as a histogram. 13

14 5.5 Slip length Upon obtaining these velocity profiles, it is suspected that there will exist some conditions where the MD result does not agree with the no-slip solution to the Navier-Stokes equation. In these cases, it is said that the fluid is slipping over the solid boundary. A slip-length is a quantisation of this slipping. The slip length is calculated by extrapolating the linear section of the velocity profile until the wallvelocity has been reached, the slip-length is then given by the extrapolation distance, ie: Figure 7: Slip-length definition. Where the blue-dotted line is the no-slip solution to the NS equation and the redline is the MD result (or the NS solution with slip assumed). In this particular case, the slip-length is Results 6.1 Energy Conservation One of the most important aspects of an MD system is that it conserves energy in systems where there are no body or boundary forces applied, ie the first set of simulations. This is checked by running free simulations, that is, simulations with no thermostats applied to the system. It was found that the simulations were conserving energy properly, which is demonstrated by one set of data from a large set that demonstrate such results: 14

15 Figure 8: Energy graphs for 100 particle, 2D system. Immediately it is seen that the simulation is conserving energy. Also note that the kinetic and potential energies take some time to get to the equilibrium states. This time must be accounted for upon taking later calculations. Now that it is known that the system is conserving energy, further calculations can be submitted. 6.2 Pressure Pressure calculations were made on a 3D system of 729 particles, initialised in a cube with 9 particles for its side length. The pressure was calculated via (28), and the simulation was repeated 30 times to gain the error readings of 2σ. The system temperature and density were varied and the pressure results were compared to those of Lentz (2013): Expected Results Results Lentz Results ρ T P P Error P Error % % % % % % Figure 9: Pressure results. The results show that the simulation pressure is in very good agreeance with the expected results. It is also seen that the best result occurs for very low system 15

16 density, whereas this same system is Lentz worst result. The reason for this is unknown and requires further investigation. 6.2 Diffusion & Viscosity Diffusion was calculated via an algorithm based on section 5.3. The calculation was repeated 64 times to gain error estimates and the result was then compared to Rahman (1967): Figure 10: Mean-square displacement versus time. From figure 10, the result is descaled for Argon (σ = 3.4E 10, ε = 120k B ) and it is found that for T = 94.4 K and ρ = 1.374g cm 3, D = (3.31 ± 1.88) 10 9 m 2 /s. Using this value for D, the viscosity μ is calculated using (33) and it is found that μ = (5.82 ± 3.31) 10 5 m 2 /s. For the specified temperatures, the expected results are D = m 2 /s and the range for viscosity is μ = m 2 /s. So it is seen that the results somewhat line up with the literature, however the errors involved are large, indicating that this method, or at least the algorithm used, needs refining. 6.2 Velocity Profiles & Slip lengths. Several Couette flow simulations were run for various wall densities and wall-fluid interaction strengths. The trends in the literature (Thompson and Robbins) show that a systems slip length will increase with increasing wall density and decreasing wall-fluid interacting strength. This is due to changes in the corrugation the fluid particles see in the wall potential, essentially changing the friction that the fluid particles experience. For a low wall density, the wall potential is very corrugated and the fluid particles can get stuck in these corrugations and be dragged along by the wall, decreasing slip. Varying the wall-fluid interaction strength simply changes how hard the fluid particles stick to the wall. The simulations were run with D LJ particles and 225 wall particles. The system temperature was held constant at T = 1.3 and the system density was 16

17 ρ f = The simulation was allowed to run for integration steps with r c = steps were used for the system to come to a steady flow, the remaining steps were used to sample and average the velocity profile. The wall density was varied between ρ w = ρ f and ρ w = 2.52ρ f. The channel had dimensions of length l = 63 and width w = The results were as follows: With associated slip lengths: Figure 11: Couette flow velocity profile. 17

18 Wall-Density ( ρ w ρ ) Wall-Fluid Interaction strength (ε wf ) Slip Length (x/σ) Figure 12: Slip lengths. The results show that the trend of the literature has been matched. It is observed that an increase in slip length occurs with an increasing wall density and a decreasing wall-fluid interaction strength. It is also observed that a negative sliplength occurs for certain values of the parameters. This is what the literature refers to as a lock-length. It occurs when the fluid s velocity profile matches the wall velocity before the fluid has reached the wall. This occurs because multiple layers of the fluid have stuck to the wall and are now essentially acting as wall particles themselves. This explains the strange non-linearities of the second and third velocity profiles, which occur due to the remaining fluid particles interacting with both wall-like fluid particles and wall particles. However, speaking in quantitative terms, the positive slip lengths calculated are not correct in reference to the literature, in fact they are way off. Unfortunately the reason for this has not been systematically investigated, due to the large number of possible causes (ie, thermostat, 2D simulation instead of 3D, differing shear rates to that of the literature). 7 Visuals On top of the results presented, some more visually aesthetic results were also obtained in the form of videos. Links can be found below: 2D 100 particle system (x0.5 speed): 3D 1000 particle system (x0.75 speed): 18

19 Couette flow system: 8 Conclusion An overview of Molecular Dynamics at a basic level and results obtained from the simulations have been presented. The algorithms written conserve energy and produce thermodynamic calculations which agree reasonably well with the expected results from the literature, indicating the simulations are giving a physically accurate representation of the mechanisms occurring within nanoscalevolume, molecular systems. Couette flow, an analytic solution to the Navier-stokes solution, was also compared to the results from MD simulations, and it was found that a slip condition is relevant, and slip does increase for increasing wall density and decreasing wall-fluid interaction strength, as suggested by the literature. However, there were some results that did not agree with literature. These results will require further investigation to resolve. 9 Acknowledgements Special thanks go to Thomas Tommy Tomlinson Nollan for his assistance early on in this project with learning MATLAB. References Frenkel, D, & Smit, B 2001, Understanding Molecular Simulation: From Algorithms to Applications, Academic Press, Amsterdam, NLD. Available from: ProQuest ebrary. [24 February 2016]. Hünenberger, P.H., Thermostat algorithms for molecular dynamics simulations. In Advanced computer simulation (pp ). Springer Berlin Heidelberg. Verlet, L., Computer" experiments" on classical fluids. I. Thermodynamical properties of Lennard-Jones molecules. Physical review,159(1), p.98. Lentz, L., Final Project: MD Simulationof Liquid Argon, Department of Mechanical Engineering, Massachusetts Institute of Technology, viewed 25/02/2016 < Rahman, A., Correlations in the motion of atoms in liquid argon. Physical Review, 136(2A), p.a405. Thompson, P.A. and Robbins, M.O., Shear flow near solids: Epitaxial order and flow boundary conditions. Physical review A, 41(12), p

20 20

Fluid Mechanics II Viscosity and shear stresses

Fluid Mechanics II Viscosity and shear stresses Fluid Mechanics II Viscosity and shear stresses Shear stresses in a Newtonian fluid A fluid at rest can not resist shearing forces. Under the action of such forces it deforms continuously, however small

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

4. The Green Kubo Relations

4. The Green Kubo Relations 4. The Green Kubo Relations 4.1 The Langevin Equation In 1828 the botanist Robert Brown observed the motion of pollen grains suspended in a fluid. Although the system was allowed to come to equilibrium,

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

Modeling the combined effect of surface roughness and shear rate on slip flow of simple fluids

Modeling the combined effect of surface roughness and shear rate on slip flow of simple fluids Modeling the combined effect of surface roughness and shear rate on slip flow of simple fluids Anoosheh Niavarani and Nikolai Priezjev www.egr.msu.edu/~niavaran November 2009 A. Niavarani and N.V. Priezjev,

More information

A comparative study between dissipative particle dynamics and molecular dynamics for simple- and complex-geometry flows

A comparative study between dissipative particle dynamics and molecular dynamics for simple- and complex-geometry flows THE JOURNAL OF CHEMICAL PHYSICS 123, 104107 2005 A comparative study between dissipative particle dynamics and molecular dynamics for simple- and complex-geometry flows Eric E. Keaveny, Igor V. Pivkin,

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

7 The Navier-Stokes Equations

7 The Navier-Stokes Equations 18.354/12.27 Spring 214 7 The Navier-Stokes Equations In the previous section, we have seen how one can deduce the general structure of hydrodynamic equations from purely macroscopic considerations and

More information

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

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

Fundamentals of Fluid Dynamics: Elementary Viscous Flow

Fundamentals of Fluid Dynamics: Elementary Viscous Flow Fundamentals of Fluid Dynamics: Elementary Viscous Flow Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Institute of Fundamental Technological Research

More information

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost Game and Media Technology Master Program - Utrecht University Dr. Nicolas Pronost Soft body physics Soft bodies In reality, objects are not purely rigid for some it is a good approximation but if you hit

More information

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Soft-Body Physics Soft Bodies Realistic objects are not purely rigid. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Deformed

More information

Lecture 3. Properties of Fluids 11/01/2017. There are thermodynamic properties of fluids like:

Lecture 3. Properties of Fluids 11/01/2017. There are thermodynamic properties of fluids like: 11/01/2017 Lecture 3 Properties of Fluids There are thermodynamic properties of fluids like: Pressure, p (N/m 2 ) or [ML -1 T -2 ], Density, ρ (kg/m 3 ) or [ML -3 ], Specific weight, γ = ρg (N/m 3 ) or

More information

Turbulence is a ubiquitous phenomenon in environmental fluid mechanics that dramatically affects flow structure and mixing.

Turbulence is a ubiquitous phenomenon in environmental fluid mechanics that dramatically affects flow structure and mixing. Turbulence is a ubiquitous phenomenon in environmental fluid mechanics that dramatically affects flow structure and mixing. Thus, it is very important to form both a conceptual understanding and a quantitative

More information

7. Basics of Turbulent Flow Figure 1.

7. Basics of Turbulent Flow Figure 1. 1 7. Basics of Turbulent Flow Whether a flow is laminar or turbulent depends of the relative importance of fluid friction (viscosity) and flow inertia. The ratio of inertial to viscous forces is the Reynolds

More information

Coupled continuum hydrodynamics and molecular dynamics method for multiscale simulation

Coupled continuum hydrodynamics and molecular dynamics method for multiscale simulation Coupled continuum hydrodynamics and molecular dynamics method for multiscale simulation Matthew K. BORG 1,, Duncan A. LOCKERBY 2, Jason M. REESE 1 * Corresponding author: Tel.: +44() 141 548 4386; Email:

More information

Differential relations for fluid flow

Differential relations for fluid flow Differential relations for fluid flow In this approach, we apply basic conservation laws to an infinitesimally small control volume. The differential approach provides point by point details of a flow

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

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

- Marine Hydrodynamics. Lecture 4. Knowns Equations # Unknowns # (conservation of mass) (conservation of momentum)

- Marine Hydrodynamics. Lecture 4. Knowns Equations # Unknowns # (conservation of mass) (conservation of momentum) 2.20 - Marine Hydrodynamics, Spring 2005 Lecture 4 2.20 - Marine Hydrodynamics Lecture 4 Introduction Governing Equations so far: Knowns Equations # Unknowns # density ρ( x, t) Continuity 1 velocities

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

150A Review Session 2/13/2014 Fluid Statics. Pressure acts in all directions, normal to the surrounding surfaces

150A Review Session 2/13/2014 Fluid Statics. Pressure acts in all directions, normal to the surrounding surfaces Fluid Statics Pressure acts in all directions, normal to the surrounding surfaces or Whenever a pressure difference is the driving force, use gauge pressure o Bernoulli equation o Momentum balance with

More information

Physics 562: Statistical Mechanics Spring 2003, James P. Sethna Homework 5, due Wednesday, April 2 Latest revision: April 4, 2003, 8:53 am

Physics 562: Statistical Mechanics Spring 2003, James P. Sethna Homework 5, due Wednesday, April 2 Latest revision: April 4, 2003, 8:53 am Physics 562: Statistical Mechanics Spring 2003, James P. Sethna Homework 5, due Wednesday, April 2 Latest revision: April 4, 2003, 8:53 am Reading David Chandler, Introduction to Modern Statistical Mechanics,

More information

Boiling Heat Transfer and Two-Phase Flow Fall 2012 Rayleigh Bubble Dynamics. Derivation of Rayleigh and Rayleigh-Plesset Equations:

Boiling Heat Transfer and Two-Phase Flow Fall 2012 Rayleigh Bubble Dynamics. Derivation of Rayleigh and Rayleigh-Plesset Equations: Boiling Heat Transfer and Two-Phase Flow Fall 2012 Rayleigh Bubble Dynamics Derivation of Rayleigh and Rayleigh-Plesset Equations: Let us derive the Rayleigh-Plesset Equation as the Rayleigh equation can

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

Figure 1: Doing work on a block by pushing it across the floor.

Figure 1: Doing work on a block by pushing it across the floor. Work Let s imagine I have a block which I m pushing across the floor, shown in Figure 1. If I m moving the block at constant velocity, then I know that I have to apply a force to compensate the effects

More information

Colloidal Suspension Rheology Chapter 1 Study Questions

Colloidal Suspension Rheology Chapter 1 Study Questions Colloidal Suspension Rheology Chapter 1 Study Questions 1. What forces act on a single colloidal particle suspended in a flowing fluid? Discuss the dependence of these forces on particle radius. 2. What

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

We may have a general idea that a solid is hard and a fluid is soft. This is not satisfactory from

We may have a general idea that a solid is hard and a fluid is soft. This is not satisfactory from Chapter 1. Introduction 1.1 Some Characteristics of Fluids We may have a general idea that a solid is hard and a fluid is soft. This is not satisfactory from scientific or engineering point of view. In

More information

Modeling Complex Flows! Direct Numerical Simulations! Computational Fluid Dynamics!

Modeling Complex Flows! Direct Numerical Simulations! Computational Fluid Dynamics! http://www.nd.edu/~gtryggva/cfd-course/! Modeling Complex Flows! Grétar Tryggvason! Spring 2011! Direct Numerical Simulations! In direct numerical simulations the full unsteady Navier-Stokes equations

More information

Homework 4 in 5C1212; Part A: Incompressible Navier- Stokes, Finite Volume Methods

Homework 4 in 5C1212; Part A: Incompressible Navier- Stokes, Finite Volume Methods Homework 4 in 5C11; Part A: Incompressible Navier- Stokes, Finite Volume Methods Consider the incompressible Navier Stokes in two dimensions u x + v y = 0 u t + (u ) x + (uv) y + p x = 1 Re u + f (1) v

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

Lecture 8: Tissue Mechanics

Lecture 8: Tissue Mechanics Computational Biology Group (CoBi), D-BSSE, ETHZ Lecture 8: Tissue Mechanics Prof Dagmar Iber, PhD DPhil MSc Computational Biology 2015/16 7. Mai 2016 2 / 57 Contents 1 Introduction to Elastic Materials

More information

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

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

More information

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

Boundary-Layer Theory

Boundary-Layer Theory Hermann Schlichting Klaus Gersten Boundary-Layer Theory With contributions from Egon Krause and Herbert Oertel Jr. Translated by Katherine Mayes 8th Revised and Enlarged Edition With 287 Figures and 22

More information

FORMULA SHEET. General formulas:

FORMULA SHEET. General formulas: FORMULA SHEET You may use this formula sheet during the Advanced Transport Phenomena course and it should contain all formulas you need during this course. Note that the weeks are numbered from 1.1 to

More information

Exercise: concepts from chapter 10

Exercise: concepts from chapter 10 Reading:, Ch 10 1) The flow of magma with a viscosity as great as 10 10 Pa s, let alone that of rock with a viscosity of 10 20 Pa s, is difficult to comprehend because our common eperience is with s like

More information

Fluid Mechanics. Chapter 9 Surface Resistance. Dr. Amer Khalil Ababneh

Fluid Mechanics. Chapter 9 Surface Resistance. Dr. Amer Khalil Ababneh Fluid Mechanics Chapter 9 Surface Resistance Dr. Amer Khalil Ababneh Wind tunnel used for testing flow over models. Introduction Resistances exerted by surfaces are a result of viscous stresses which create

More information

Chapter 9b: Numerical Methods for Calculus and Differential Equations. Initial-Value Problems Euler Method Time-Step Independence MATLAB ODE Solvers

Chapter 9b: Numerical Methods for Calculus and Differential Equations. Initial-Value Problems Euler Method Time-Step Independence MATLAB ODE Solvers Chapter 9b: Numerical Methods for Calculus and Differential Equations Initial-Value Problems Euler Method Time-Step Independence MATLAB ODE Solvers Acceleration Initial-Value Problems Consider a skydiver

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

ME 262 BASIC FLUID MECHANICS Assistant Professor Neslihan Semerci Lecture 4. (Buoyancy and Viscosity of water)

ME 262 BASIC FLUID MECHANICS Assistant Professor Neslihan Semerci Lecture 4. (Buoyancy and Viscosity of water) ME 262 BASIC FLUID MECHANICS Assistant Professor Neslihan Semerci Lecture 4 (Buoyancy and Viscosity of water) 16. BUOYANCY Whenever an object is floating in a fluid or when it is completely submerged in

More information

Collective Effects. Equilibrium and Nonequilibrium Physics

Collective Effects. Equilibrium and Nonequilibrium Physics Collective Effects in Equilibrium and Nonequilibrium Physics: Lecture 5, April 14, 2006 1 Collective Effects in Equilibrium and Nonequilibrium Physics Website: http://cncs.bnu.edu.cn/mccross/course/ Caltech

More information

PHY 481/581. Some classical/quantum physics for the nanometer length scale.

PHY 481/581. Some classical/quantum physics for the nanometer length scale. PHY 481/581 Some classical/quantum physics for the nanometer length scale http://creativecommons.org/licenses/by-nc-sa/3.0/ 1 What is nano-science? the science of materials whose properties scale with

More information

Collective Effects. Equilibrium and Nonequilibrium Physics

Collective Effects. Equilibrium and Nonequilibrium Physics 1 Collective Effects in Equilibrium and Nonequilibrium Physics: Lecture 5, April 14, 2006 1 Collective Effects in Equilibrium and Nonequilibrium Physics Website: http://cncs.bnu.edu.cn/mccross/course/

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

A combined application of the integral wall model and the rough wall rescaling-recycling method

A combined application of the integral wall model and the rough wall rescaling-recycling method AIAA 25-299 A combined application of the integral wall model and the rough wall rescaling-recycling method X.I.A. Yang J. Sadique R. Mittal C. Meneveau Johns Hopkins University, Baltimore, MD, 228, USA

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

1. The Properties of Fluids

1. The Properties of Fluids 1. The Properties of Fluids [This material relates predominantly to modules ELP034, ELP035] 1.1 Fluids 1.1 Fluids 1.2 Newton s Law of Viscosity 1.3 Fluids Vs Solids 1.4 Liquids Vs Gases 1.5 Causes of viscosity

More information

Fluid Mechanics. Jim Emery 9/3/ Bernoulli s Law 2. 2 Torricelli s Law 3. 3 Time to Empty a Tank 3. 4 Viscosity 4. 5 The Acceleration 5

Fluid Mechanics. Jim Emery 9/3/ Bernoulli s Law 2. 2 Torricelli s Law 3. 3 Time to Empty a Tank 3. 4 Viscosity 4. 5 The Acceleration 5 Fluid Mechanics Jim Emery 9/3/2010 Contents 1 Bernoulli s Law 2 2 Torricelli s Law 3 3 Time to Empty a Tank 3 4 Viscosity 4 5 The Acceleration 5 6 The Equation of Motion Due to Cauchy 7 7 The Deformation

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

Shell Balances in Fluid Mechanics

Shell Balances in Fluid Mechanics Shell Balances in Fluid Mechanics R. Shankar Subramanian Department of Chemical and Biomolecular Engineering Clarkson University When fluid flow occurs in a single direction everywhere in a system, shell

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

Part I.

Part I. Part I bblee@unimp . Introduction to Mass Transfer and Diffusion 2. Molecular Diffusion in Gasses 3. Molecular Diffusion in Liquids Part I 4. Molecular Diffusion in Biological Solutions and Gels 5. Molecular

More information

Nanoscale Energy Transport and Conversion A Parallel Treatment of Electrons, Molecules, Phonons, and Photons

Nanoscale Energy Transport and Conversion A Parallel Treatment of Electrons, Molecules, Phonons, and Photons Nanoscale Energy Transport and Conversion A Parallel Treatment of Electrons, Molecules, Phonons, and Photons Gang Chen Massachusetts Institute of Technology OXFORD UNIVERSITY PRESS 2005 Contents Foreword,

More information

2. FLUID-FLOW EQUATIONS SPRING 2019

2. FLUID-FLOW EQUATIONS SPRING 2019 2. FLUID-FLOW EQUATIONS SPRING 2019 2.1 Introduction 2.2 Conservative differential equations 2.3 Non-conservative differential equations 2.4 Non-dimensionalisation Summary Examples 2.1 Introduction Fluid

More information

Convective Mass Transfer

Convective Mass Transfer Convective Mass Transfer Definition of convective mass transfer: The transport of material between a boundary surface and a moving fluid or between two immiscible moving fluids separated by a mobile interface

More information

Module 3: "Thin Film Hydrodynamics" Lecture 11: "" The Lecture Contains: Micro and Nano Scale Hydrodynamics with and without Free Surfaces

Module 3: Thin Film Hydrodynamics Lecture 11:  The Lecture Contains: Micro and Nano Scale Hydrodynamics with and without Free Surfaces The Lecture Contains: Micro and Nano Scale Hydrodynamics with and without Free Surfaces Order of Magnitude Analysis file:///e /courses/colloid_interface_science/lecture11/11_1.htm[6/16/2012 1:39:56 PM]

More information

FALLING FILM FLOW ALONG VERTICAL PLATE WITH TEMPERATURE DEPENDENT PROPERTIES

FALLING FILM FLOW ALONG VERTICAL PLATE WITH TEMPERATURE DEPENDENT PROPERTIES Proceedings of the International Conference on Mechanical Engineering 2 (ICME2) 8-2 December 2, Dhaka, Bangladesh ICME-TH-6 FALLING FILM FLOW ALONG VERTICAL PLATE WITH TEMPERATURE DEPENDENT PROPERTIES

More information

CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION

CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION 7.1 THE NAVIER-STOKES EQUATIONS Under the assumption of a Newtonian stress-rate-of-strain constitutive equation and a linear, thermally conductive medium,

More information

Chapter 1. Continuum mechanics review. 1.1 Definitions and nomenclature

Chapter 1. Continuum mechanics review. 1.1 Definitions and nomenclature Chapter 1 Continuum mechanics review We will assume some familiarity with continuum mechanics as discussed in the context of an introductory geodynamics course; a good reference for such problems is Turcotte

More information

Brownian Motion and Langevin Equations

Brownian Motion and Langevin Equations 1 Brownian Motion and Langevin Equations 1.1 Langevin Equation and the Fluctuation- Dissipation Theorem The theory of Brownian motion is perhaps the simplest approximate way to treat the dynamics of nonequilibrium

More information

Turbulence Modeling I!

Turbulence Modeling I! Outline! Turbulence Modeling I! Grétar Tryggvason! Spring 2010! Why turbulence modeling! Reynolds Averaged Numerical Simulations! Zero and One equation models! Two equations models! Model predictions!

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

Physical Properties of Fluids

Physical Properties of Fluids Physical Properties of Fluids Viscosity: Resistance to relative motion between adjacent layers of fluid. Dynamic Viscosity:generally represented as µ. A flat plate moved slowly with a velocity V parallel

More information

Simulating Drag Crisis for a Sphere Using Skin Friction Boundary Conditions

Simulating Drag Crisis for a Sphere Using Skin Friction Boundary Conditions Simulating Drag Crisis for a Sphere Using Skin Friction Boundary Conditions Johan Hoffman May 14, 2006 Abstract In this paper we use a General Galerkin (G2) method to simulate drag crisis for a sphere,

More information

Modeling Mechanical Systems

Modeling Mechanical Systems Modeling Mechanical Systems Mechanical systems can be either translational or rotational. Although the fundamental relationships for both types are derived from Newton s law, they are different enough

More information

Exercise 5: Exact Solutions to the Navier-Stokes Equations I

Exercise 5: Exact Solutions to the Navier-Stokes Equations I Fluid Mechanics, SG4, HT009 September 5, 009 Exercise 5: Exact Solutions to the Navier-Stokes Equations I Example : Plane Couette Flow Consider the flow of a viscous Newtonian fluid between two parallel

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

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

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

More information

An Overview of Fluid Animation. Christopher Batty March 11, 2014

An Overview of Fluid Animation. Christopher Batty March 11, 2014 An Overview of Fluid Animation Christopher Batty March 11, 2014 What distinguishes fluids? What distinguishes fluids? No preferred shape. Always flows when force is applied. Deforms to fit its container.

More information

Boundary Conditions for the Moving Contact Line Problem. Abstract

Boundary Conditions for the Moving Contact Line Problem. Abstract Boundary Conditions for the Moving Contact Line Problem Weiqing Ren Courant Institute of Mathematical Sciences, New York University, New York, NY 10012, USA Weinan E Department of Mathematics and PACM,

More information

Monte Carlo Simulations for a Soft Sphere Fluid

Monte Carlo Simulations for a Soft Sphere Fluid Monte Carlo Simulations for a Soft Sphere Fluid Patrick Kreitzberg Advisor: Dr. David Roundy May 8 th, 2015 1 Contents 1 2 3 5 7 Abstract Introduction Methods Results and Discussion Conclusion Acknowledgments

More information

Chemical and Biomolecular Engineering 150A Transport Processes Spring Semester 2017

Chemical and Biomolecular Engineering 150A Transport Processes Spring Semester 2017 Chemical and Biomolecular Engineering 150A Transport Processes Spring Semester 2017 Objective: Text: To introduce the basic concepts of fluid mechanics and heat transfer necessary for solution of engineering

More information

CHAPTER 1 Fluids and their Properties

CHAPTER 1 Fluids and their Properties FLUID MECHANICS Gaza CHAPTER 1 Fluids and their Properties Dr. Khalil Mahmoud ALASTAL Objectives of this Chapter: Define the nature of a fluid. Show where fluid mechanics concepts are common with those

More information

Stick and Slip Behaviour of Confined Oligomer Melts under Shear. A Molecular-Dynamics Study.

Stick and Slip Behaviour of Confined Oligomer Melts under Shear. A Molecular-Dynamics Study. EUROPHYSICS LETTERS Europhys. Lett., 24 (2), pp. 99-104 (1993) 10 October 1993 Stick and Slip Behaviour of Confined Oligomer Melts under Shear. A Molecular-Dynamics Study. E. MANIAS(*), G. HADZIIOANNOU(*),

More information

Microfluidics 1 Basics, Laminar flow, shear and flow profiles

Microfluidics 1 Basics, Laminar flow, shear and flow profiles MT-0.6081 Microfluidics and BioMEMS Microfluidics 1 Basics, Laminar flow, shear and flow profiles 11.1.2017 Ville Jokinen Outline of the next 3 weeks: Today: Microfluidics 1: Laminar flow, flow profiles,

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

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

BFC FLUID MECHANICS BFC NOOR ALIZA AHMAD

BFC FLUID MECHANICS BFC NOOR ALIZA AHMAD BFC 10403 FLUID MECHANICS CHAPTER 1.0: Principles of Fluid 1.1 Introduction to Fluid Mechanics 1.2 Thermodynamic Properties of a Fluid: Density, specific weight, specific gravity, viscocity (kelikatan)berat

More information

Interface Resistance and Thermal Transport in Nano-Confined Liquids

Interface Resistance and Thermal Transport in Nano-Confined Liquids 1 Interface Resistance and Thermal Transport in Nano-Confined Liquids Murat Barisik and Ali Beskok CONTENTS 1.1 Introduction...1 1.2 Onset of Continuum Behavior...2 1.3 Boundary Treatment Effects on Interface

More information

Analytical and Numerical Study of Coupled Atomistic-Continuum Methods for Fluids

Analytical and Numerical Study of Coupled Atomistic-Continuum Methods for Fluids Analytical and Numerical Study of Coupled Atomistic-Continuum Methods for Fluids Weiqing Ren Courant Institute, NYU Joint work with Weinan E Multiscale modeling for two types of problems: Complex fluids

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

Time-Dependent Statistical Mechanics 5. The classical atomic fluid, classical mechanics, and classical equilibrium statistical mechanics

Time-Dependent Statistical Mechanics 5. The classical atomic fluid, classical mechanics, and classical equilibrium statistical mechanics Time-Dependent Statistical Mechanics 5. The classical atomic fluid, classical mechanics, and classical equilibrium statistical mechanics c Hans C. Andersen October 1, 2009 While we know that in principle

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

Principles of Convection

Principles of Convection Principles of Convection Point Conduction & convection are similar both require the presence of a material medium. But convection requires the presence of fluid motion. Heat transfer through the: Solid

More information

Computer Fluid Dynamics E181107

Computer Fluid Dynamics E181107 Computer Fluid Dynamics E181107 2181106 Transport equations, Navier Stokes equations Remark: foils with black background could be skipped, they are aimed to the more advanced courses Rudolf Žitný, Ústav

More information

Nosé-Hoover chain method for nonequilibrium molecular dynamics simulation

Nosé-Hoover chain method for nonequilibrium molecular dynamics simulation PHYSICAL REVIEW E VOLUME 61, NUMBER 5 MAY 000 Nosé-Hoover chain method for nonequilibrium molecular dynamics simulation A. C. Brańka Institute of Molecular Physics, Polish Academy of Sciences, Smoluchowskiego

More information

Transport processes. 7. Semester Chemical Engineering Civil Engineering

Transport processes. 7. Semester Chemical Engineering Civil Engineering Transport processes 7. Semester Chemical Engineering Civil Engineering 1. Elementary Fluid Dynamics 2. Fluid Kinematics 3. Finite Control Volume Analysis 4. Differential Analysis of Fluid Flow 5. Viscous

More information

Laminar Boundary Layers. Answers to problem sheet 1: Navier-Stokes equations

Laminar Boundary Layers. Answers to problem sheet 1: Navier-Stokes equations Laminar Boundary Layers Answers to problem sheet 1: Navier-Stokes equations The Navier Stokes equations for d, incompressible flow are + v ρ t + u + v v ρ t + u v + v v = 1 = p + µ u + u = p ρg + µ v +

More information

Introduction to Heat and Mass Transfer. Week 9

Introduction to Heat and Mass Transfer. Week 9 Introduction to Heat and Mass Transfer Week 9 補充! Multidimensional Effects Transient problems with heat transfer in two or three dimensions can be considered using the solutions obtained for one dimensional

More information

Fluid Animation. Christopher Batty November 17, 2011

Fluid Animation. Christopher Batty November 17, 2011 Fluid Animation Christopher Batty November 17, 2011 What distinguishes fluids? What distinguishes fluids? No preferred shape Always flows when force is applied Deforms to fit its container Internal forces

More information

Introduction to Aerodynamics. Dr. Guven Aerospace Engineer (P.hD)

Introduction to Aerodynamics. Dr. Guven Aerospace Engineer (P.hD) Introduction to Aerodynamics Dr. Guven Aerospace Engineer (P.hD) Aerodynamic Forces All aerodynamic forces are generated wither through pressure distribution or a shear stress distribution on a body. The

More information

Liquids and solids are essentially incompressible substances and the variation of their density with pressure is usually negligible.

Liquids and solids are essentially incompressible substances and the variation of their density with pressure is usually negligible. Properties of Fluids Intensive properties are those that are independent of the mass of a system i.e. temperature, pressure and density. Extensive properties are those whose values depend on the size of

More information

Chapter 9: Statistical Mechanics

Chapter 9: Statistical Mechanics Chapter 9: Statistical Mechanics Chapter 9: Statistical Mechanics...111 9.1 Introduction...111 9.2 Statistical Mechanics...113 9.2.1 The Hamiltonian...113 9.2.2 Phase Space...114 9.2.3 Trajectories and

More information

Computational Astrophysics

Computational Astrophysics Computational Astrophysics Lecture 1: Introduction to numerical methods Lecture 2:The SPH formulation Lecture 3: Construction of SPH smoothing functions Lecture 4: SPH for general dynamic flow Lecture

More information

Fluid Mechanics Prof. T.I. Eldho Department of Civil Engineering Indian Institute of Technology, Bombay. Lecture - 17 Laminar and Turbulent flows

Fluid Mechanics Prof. T.I. Eldho Department of Civil Engineering Indian Institute of Technology, Bombay. Lecture - 17 Laminar and Turbulent flows Fluid Mechanics Prof. T.I. Eldho Department of Civil Engineering Indian Institute of Technology, Bombay Lecture - 17 Laminar and Turbulent flows Welcome back to the video course on fluid mechanics. In

More information

Lecturer, Department t of Mechanical Engineering, SVMIT, Bharuch

Lecturer, Department t of Mechanical Engineering, SVMIT, Bharuch Fluid Mechanics By Ashish J. Modi Lecturer, Department t of Mechanical Engineering, i SVMIT, Bharuch Review of fundamentals Properties of Fluids Introduction Any characteristic of a system is called a

More information