Direct Simulation Monte Carlo (DSMC) of gas flows

Size: px
Start display at page:

Download "Direct Simulation Monte Carlo (DSMC) of gas flows"

Transcription

1 Direct Simulation Monte Carlo (DSMC) of gas flows Monte Carlo method: Definitions Basic concepts of kinetic theory of gases Applications of DSMC Generic algorithm of the DSMC method Summary Reading: G.A. Bird, Molecular gas dynamics and the direct simulation of gas flows. Clarendon Press, 994

2 Direct Simulation Monte Carlo of gas flows: Definitions Monte Carlo method is a generic numerical method for a variety of mathematical problems based on computer generation of random numbers. Direct simulation Monte Carlo (DSMC) method is the Monte Carlo method for simulation of dilute gas flows on molecular level, i.e. on the level of individual molecules. To date DSMC is the basic numerical method in the kinetic theory of gases and rarefied gas dynamics. Kinetic theory of gases is a part of statistical physics where the flow of gases are considered on a molecular level and described in terms of changes of probabilities of various states of gas molecules in space and in time.

3 Dilute gas DSMC is applied for simulations of flows of a dilute gas Dilute gas is a gas where the density parameter ε (volume fraction) is small ε = n d 3 << n is the numerical concentration of gas molecule d is the diameter of gas molecules In Earth atmosphere, air can be considered as a dilute gas at any altitude, e.g. on the Earth surface n =.7 x 0 5 m -3, d = 3.7 x 0-0 m, and ε =.4 x 0-3 For a dilute gas Collision length scale d is much smaller then the average distance between molecules l = / n /3 = d / ε /3, d << l => most of time every molecule moves without interactions with other ones, hence, an interaction between molecules can be considered as an instant change of their velocities, i.e. as a collision between billiardball -like particles. Real process of molecular motion can be divided into two stages: (I) collisionless (free) motion of molecules and (II) instant collisions between them If P N is the probability of simultaneous interaction between N gas molecules, then P N+ /P N ε => only binary collisions between gas molecules are important 3

4 Flow regimes of a dilute gas Collision frequency ν of a molecule with diameter d is the averaged number of collisions of this molecule per unit time Relative velocity of molecules, g = v -v Collision cross-section σ = π d g ν = nσg t t = nσg g t d Mean free path of a molecule λ = g ( / ν ) = / ( n σ ) Knudsen number Kn = λ / L = / ( n σ L ), L is the flow length scale Knudsen number is a measure of importance of collisions in a gas flow Kn << (Kn < 0.0) Kn ~ Kn >> (Kn > 0) Continuum flow Transitional flow Free molecular (collisionless) flow L Local equilibrium Non-equilibrium flows 4

5 Applications of DSMC simulations (I) Aerospace applications: Flows in upper atmosphere and in vacuum Satellites and spacecrafts on LEO and in deep space Re-entry vehicles in upper atmosphere Nozzles and jets in space environment Planetary science and astrophysics Dynamics of upper planetary atmospheres Global atmospheric evolution (Io, Enceladus, etc) Atmospheres of small bodies (comets, etc) 5

6 Applications of DSMC simulations (II) Fast, non-equilibrium gas flows (laser ablation, evaporation, deposition) Flows on microscale, microfluidics Flows in electronic devices and MEMS Flows in microchannes Flow over microparticles and clusters HD Si wafer Soot clusters 6

7 Basic approach of the DSMC method Gas is represented by a set of N simulated molecules (similar to MD) X(t)=(r (t),v (t),,r N (t),v N (t)) Velocities V i (and coordinates r i ) of gas molecules are random variables. Thus, DSMC is a probabilistic approach in contrast to MD which is a deterministic one. Gas flow is simulated as a change of X(t) in time due to Free motion of molecules or motion under the effect of external (e.g. gravity) forces Pair interactions (collisions) between gas molecules Interaction of molecules with surfaces of streamlined bodies, obstacles, channel walls, etc. Pair collision r i f ei v i External force field f e In typical DSMC simulations (e.g. flow over a vehicle in Earth atmosphere) the computational domain is a part of a larger flow. Hence, some boundaries of a domain are transparent for molecules and number of simulated molecules, N, is varied in time. Rebound of a molecule from the wall Computational domain 7

8 Statistical weight of simulated molecules in DSMC Number of collisions between molecules is defined by the collision frequency ν = n σ g. For the same velocities of gas molecules, the number of collisions depends on n and σ. Consider two flows n, σ n, σ If n σ = n σ, then the collision frequencies are the same in both flows. If other conditions in both flows are the same, then two flows are equivalent to each other. Thus, in DSMC simulations the number of simulated molecules can not be equal to the number of molecules in real flow. This differs DSMC from MD, where every simulated particle represents one molecule of the real system. Every simulated molecule in DSMC represents W molecules of real gas, where W = n / n sim is the statistical weight of a simulated molecule. In order to make flow of simulated molecules the same as compared to the flow of real gas, the cross-section of simulated molecules is calculated as follows σ sim n = σ n sim = σw 8

9 DSMC algorithm (after G.A. Bird) Any process (evolving in time or steady-state) is divided into short time intervals time steps t X(t)=(r (t),v (t),,r N (t),v N (t)) X n = X(t n ), state of simulated molecules at time t n X n+ = X(t n+ ), state of simulated molecules at time t n+ = t n + t At every time step, the change of X n into X n+ (X n X n+ ) is splitted into a sequence of three basic stages Stage I. Collisionless motion of molecules (solution of the motion equations) X n X * Stage II. Collision sampling (pair collisions between molecules) X * X ** Stage III. Implementations of boundary conditions (interactions of molecules with surfaces, free inflow/outflow of molecules through boundaries, etc) X ** X n+ Thus, in contrast with MD, where interaction between particles are described by forces in equations of motion, in DSMC, interactions between particles is described by means of a special random algorithm (collision sampling) which is a core of any DSMC computer code. 9

10 DSMC vs. Molecular Dynamics (MD) simulations Both MD and DSMC are particle-based methods MD simulations: Direct solution of the motion equations at a time step m i d v dt m i i = Interaction force between molecules i and j DSMC simulations: Splitting at a time step m i d dt d v dt j f ij v i = i f + f ei = j ei f ij i =,..., External force Special probabalistic approach for sampling of binary collisions instead of direct solution of Eq. (*) (*) N Use of statistical weights i =,..., N << sim N 0

11 DSMC vs. MD and CFD in simulations of gas flows Three alternative computational methodology for simulations of gas flows MD, Molecular dynamic simulations DSMC, Direct simulation Monte Carlo CFD, Computational fluid dynamics L MD DSMC CFD Theoretical model Classical equations of motion for particles Boltzmann kinetic equation Navier-Stokes equations Gas state Dilute gas, dense gas, clusters, etc. Dilute gas Dilute gas Where applied Dense gas flows, phase changes, complex molecules Transitional and free molecular nonequilibrium flows Continuum nearequilibrium flows Typical flow length scale L Less then micrometer No limitations, usually, λ / L > 0.0 No limitations, usually, λ / L < 0. Relative computational cost High Moderate Low

12 Stage I. Collisionless motion X n = (r n,v n,,r Nn,V Nn ) X n X * For every molecule, its equations of motion are solved for a time step dr i /dt = V i, m i dv i /dt = f ei, i =,, N r i (t n )=r in, V i (t n )=V in, m i is the real mass of a gas molecule In case of free motion (f ei = 0) X * =(r *,V n,,r N*,V Nn ) r i * = r in + t V i n If external force field is present, the equations of motion are solved numerically, e.g. by the Runge-Kutta method of the second order X * =(r *,V *,,r N*,V N* ) r i = r in + ( t/) V in, V i = V in + ( t/) f ei (r in ) r i* = r in + t V i, V i* = V in + t f ei (r i )

13 Stage II. Collision sampling (after G.A. Bird) X * = (r *,V *,,r N *,V N * ) X * X ** Computational domain is divided into a mesh of cells. Cell For every molecule, the index of cell to which the molecule belongs is calculated (indexing of molecules). At a time step, only collisions between molecules belonging to the same cell are taken into account Every collision is considered as a random event occurring with some probability of collision In every cell, pairs of colliding molecules are randomly sampled (collision sampling in a cell). For every pair of colliding molecules, pre-collisional velocities are replaced by their post-collisional values. 3

14 Collision sampling in a cell : Calculation of the collision probability during time step Cell of volume V cell containing N cell molecules Molecules are assumed to be distributed homogeneously within the cell Relative velocity of molecules i and j g ij = v j v i g ij = gij σ ij(sim) j i g ij g ij t Probability of a random collision between molecules i and j during time step P ij = σ ij( sim) V g cell ij t 4

15 Collision sampling in a cell : Calculation of particle velocities after a binary collision of hard sphere Velocities before collision Velocities after collision Conservation laws of momentum, energy, and angular momentum Equations for molecule velocities after collision For hard sphere (HS) molecules unity vector n is an isotropic random vector: n x = cosθ, n y = sin θcos(πα ), n z = sin θsin(πα ), cosθ = α, sin θ = cos α i is a random number distributed with equal probability from 0 to. In a computer code, it can be generated with the help of library functions, which are called random number generators. θ 5

16 Collision sampling in a cell: The primitive scheme i = j = i + P ij = tσ ij(sim) g ij / V cell Calculation of the collision probability Disadvantage of the primitive scheme: no α < P ij P(α < P ij ) = P ij j = j + yes j < N cell yes cos θ = α sin θ = n n n x y z = cos θ = sin θcos(πα = sin θsin(πα no i = i + cos θ ) ) Does collision between molecules i and j occur? Calculation of velocities after collision Are there other pairs of molecules in the cell? Number of operation ~ N cell In real DSMC simulations, more efficient schemes for collision sampling are used, e.g. the NTC scheme by Bird yes i < N cell - no Go to the next cell 6

17 Stage III. Implementation of boundary conditions X ** = (r **,V **,,r N **,V N ** ) X ** X n+ Implementation of boundary conditions depends on the specifics of the flow problem under consideration. Typically, conditions on flow boundaries is the most specific part of the problem Examples of boundary conditions Impermeable boundary (e.g. solid surface): rebound of molecules from the wall Flow over a re-entry vehicle in Earth atmosphere Permeable boundary between the computational domain and the reservoir of molecules (e.g. Earth atmosphere) : free motion of molecules through boundary reproducing inflow/outflow fluxes Reservoir (Earth atmosphere) Computational domain 7

18 Rebound of molecules from an impermeable wall Boundary condition is based on the model describing the rebound of an individual gas molecule from the wall. The model should defined the velocity of reflected molecule as a function of the velocity of the incident molecule, V r =V r (V i,n w,t w, ). V i z y n w V r In DSMC simulations, velocity of every molecule incident to the wall is replaced by the velocity of the reflected molecule. In simulations, the Maxwell models of molecule rebound are usually applied. x T w, wall temperature Maxwell model of specular scattering: A molecule reflects from the wall like an ideal billiard ball, i.e. V rx = V ix, V ry = - V iy, V rz = V iz V r = V i ( V i n w ) n w Disadvantage: heat flux and shear drag on the wall are zero (V r = V i ). The model is capable to predict normal stress only. Maxwell model of diffuse scattering: Velocity distribution function of reflected molecules is assumed to be Maxwellian: n r mv ( ) exp 3/ ( ( / ) ) r f V r = π k m Tr ktw Random velocity of a reflected molecule can be generated using random numbers α i V V V rx ry rz = = = ( k / m) T ( k / m) T ( k / m) T w w w lgα lg α lg α 3 cos(πα sin(πα ) ) 8

19 Free inflow/outflow of molecules on a permeable boundary y Reservoir x x At every time step of DSMC simulations Computational domain. All molecules moving from the computational domain into reservoir is excluded from further simulations. Reservoir is filled by N =n V molecules, where V is the reservoir volume. Random coordinates of every molecule in reservoir are generated homogeneously, random velocities are generated from the Maxwelian distribution. x Maxwellian velocity distribution in the reservoir: n f ( V) = (π( k / m) T ) n, concentration T, temperature, U, gas velocity Random coordinates: x = x y = y z = z + ( x + ( y + ( z x ) α y z ) α ) α 3 3/ m exp ( V U ) kt 3. All molecules in the reservoir are moved : Their positions and velocities are changed with accordance to their equations of motion during a time step. 4. All molecules from the reservoir that entered the computational domain during a time step are included to the set of simulated molecules. All other molecules from the reservoir are excluded from further simulations. Random velocities: V V V x y z = U = U = U x y z ( k / m) T ( k / m) T ( k / m) T lgα lg α lgα 3 5 cos(πα cos(πα sin(πα 6 4 ) ) ) 9

20 Summary DSMC is a numerical method for simulations of free-molecular, transitional and near-continuum flows of a dilute gas on a level of individual molecules. It is usually used for flows where the local state of gas molecules is far from the local equilibrium As compared to MD, DSMC has the following distinctive features Every simulated molecule in DSMC represents W molecules in real flow, typically W >>. It makes DSMC capable for simulation of flows with almost arbitrary length scale (e.g., planetary atmosphere). Interactions between molecules are taken into account in the framework of a special collision sampling algorithm, where interactions (pair collisions) are considered as random events and simulated based on generation of random numbers. Typically, an implementation of DSMC in a computer code relays on two types of models describing Pair collision between molecules Rebound of a molecule from an impermeable wall Though in this lecture we consider only hard sphere molecules, a variety of models exists for both inter-molecular and molecule-wall collisions. These models are capable to account for many features of molecules in real gases (e.g., internal degrees of freedom, etc.) Reading: G.A. Bird, Molecular gas dynamics and the direct simulation of gas flows. Clarendon Press,

Vacuum Technology. Kinetic Theory of Gas. Dr. Philip D. Rack

Vacuum Technology. Kinetic Theory of Gas. Dr. Philip D. Rack Kinetic Theory of Gas Assistant Professor Department of Materials Science and Engineering University of Tennessee 603 Dougherty Engineering Building Knoxville, TN 3793-00 Phone: (865) 974-5344 Fax (865)

More information

Kinetic Theory of Gases. Chapter 33. Kinetic Theory of Gases

Kinetic Theory of Gases. Chapter 33. Kinetic Theory of Gases Kinetic Theory of Gases Kinetic Theory of Gases Chapter 33 Kinetic theory of gases envisions gases as a collection of atoms or molecules. Atoms or molecules are considered as particles. This is based on

More information

Statistical Mechanics, Kinetic Theory Ideal Gas. 8.01t Nov 22, 2004

Statistical Mechanics, Kinetic Theory Ideal Gas. 8.01t Nov 22, 2004 Statistical Mechanics, Kinetic Theory Ideal Gas 8.01t Nov 22, 2004 Statistical Mechanics and Thermodynamics Thermodynamics Old & Fundamental Understanding of Heat (I.e. Steam) Engines Part of Physics Einstein

More information

Basic Principles in Microfluidics

Basic Principles in Microfluidics Basic Principles in Microfluidics 1 Newton s Second Law for Fluidics Newton s 2 nd Law (F= ma) : Time rate of change of momentum of a system equal to net force acting on system!f = dp dt Sum of forces

More information

Chemistry 13: States of Matter

Chemistry 13: States of Matter Chemistry 13: States of Matter Name: Period: Date: Chemistry Content Standard: Gases and Their Properties The kinetic molecular theory describes the motion of atoms and molecules and explains the properties

More information

13.1 The Nature of Gases. What is Kinetic Theory? Kinetic Theory and a Model for Gases. Chapter 13: States of Matter. Principles of Kinetic Theory

13.1 The Nature of Gases. What is Kinetic Theory? Kinetic Theory and a Model for Gases. Chapter 13: States of Matter. Principles of Kinetic Theory Chapter 13: States of Matter The Nature of Gases The Nature of Gases kinetic molecular theory (KMT), gas pressure (pascal, atmosphere, mm Hg), kinetic energy The Nature of Liquids vaporization, evaporation,

More information

Kinetic Theory of Gases

Kinetic Theory of Gases Kinetic Theory of Gases Physics 1425 Lecture 31 Michael Fowler, UVa Bernoulli s Picture Daniel Bernoulli, in 1738, was the first to understand air pressure in terms of molecules he visualized them shooting

More information

Differential Relations for Fluid Flow. Acceleration field of a fluid. The differential equation of mass conservation

Differential Relations for Fluid Flow. Acceleration field of a fluid. The differential equation of mass conservation Differential Relations for Fluid Flow In this approach, we apply our four basic conservation laws to an infinitesimally small control volume. The differential approach provides point by point details of

More information

Vacuum Evaporation Recap

Vacuum Evaporation Recap Sputtering Vacuum Evaporation Recap Use high temperatures at high vacuum to evaporate (eject) atoms or molecules off a material surface. Use ballistic flow to transport them to a substrate and deposit.

More information

CLASSICAL CONCEPT REVIEW 8

CLASSICAL CONCEPT REVIEW 8 CLASSICAL CONCEPT REVIEW 8 Kinetic Theory Information concerning the initial motions of each of the atoms of macroscopic systems is not accessible, nor do we have the computational capability even with

More information

FLUID DYNAMICS. Intrinsic properties of fluids. Fluids behavior under various conditions

FLUID DYNAMICS. Intrinsic properties of fluids. Fluids behavior under various conditions FLUID DYNAMICS Intrinsic properties of fluids Fluids behavior under various conditions Methods by which we can manipulate and utilize the fluids to produce desired results TYPES OF FLUID FLOW Laminar or

More information

Thermodynamics: Lecture 8, Kinetic Theory

Thermodynamics: Lecture 8, Kinetic Theory Thermodynamics: Lecture 8, Kinetic Theory Chris Glosser April 15, 1 1 OUTLINE I. Assumptions of Kinetic Theory (A) Molecular Flux (B) Pressure and the Ideal Gas Law II. The Maxwell-Boltzmann Distributuion

More information

Graduate Certificate Program in Energy Conversion & Transport Offered by the Department of Mechanical and Aerospace Engineering

Graduate Certificate Program in Energy Conversion & Transport Offered by the Department of Mechanical and Aerospace Engineering Graduate Certificate Program in Energy Conversion & Transport Offered by the Department of Mechanical and Aerospace Engineering Intended Audience: Main Campus Students Distance (online students) Both Purpose:

More information

(1) The size of a gas particle is negligible as compared to the volume of the container in which the gas is placed.

(1) The size of a gas particle is negligible as compared to the volume of the container in which the gas is placed. Gas Laws and Kinetic Molecular Theory The Gas Laws are based on experiments, and they describe how a gas behaves under certain conditions. However, Gas Laws do not attempt to explain the behavior of gases.

More information

NASA STI Program... in Profile

NASA STI Program... in Profile NASA/TP 014-1854 Extension of a Kinetic Approach to Chemical Reactions to Electronic Energy Levels and Reactions Involving Charged Species with Application to DSMC Simulations Derek Shane Liechty Langley

More information

Lecture L2 - Degrees of Freedom and Constraints, Rectilinear Motion

Lecture L2 - Degrees of Freedom and Constraints, Rectilinear Motion S. Widnall 6.07 Dynamics Fall 009 Version.0 Lecture L - Degrees of Freedom and Constraints, Rectilinear Motion Degrees of Freedom Degrees of freedom refers to the number of independent spatial coordinates

More information

1 Introduction. Taking the logarithm of both sides of Equation 1.1:

1 Introduction. Taking the logarithm of both sides of Equation 1.1: j1 1 Introduction The aim of this book is to provide an understanding of the basic processes, at the atomic or molecular level, which are responsible for kinetic processes at the microscopic and macroscopic

More information

CHAPTER 12. Gases and the Kinetic-Molecular Theory

CHAPTER 12. Gases and the Kinetic-Molecular Theory CHAPTER 12 Gases and the Kinetic-Molecular Theory 1 Gases vs. Liquids & Solids Gases Weak interactions between molecules Molecules move rapidly Fast diffusion rates Low densities Easy to compress Liquids

More information

HEAT UNIT 1.1 KINETIC THEORY OF GASES. 1.1.1 Introduction. 1.1.2 Postulates of Kinetic Theory of Gases

HEAT UNIT 1.1 KINETIC THEORY OF GASES. 1.1.1 Introduction. 1.1.2 Postulates of Kinetic Theory of Gases UNIT HEAT. KINETIC THEORY OF GASES.. Introduction Molecules have a diameter of the order of Å and the distance between them in a gas is 0 Å while the interaction distance in solids is very small. R. Clausius

More information

1. The Kinetic Theory of Matter states that all matter is composed of atoms and molecules that are in a constant state of constant random motion

1. The Kinetic Theory of Matter states that all matter is composed of atoms and molecules that are in a constant state of constant random motion Physical Science Period: Name: ANSWER KEY Date: Practice Test for Unit 3: Ch. 3, and some of 15 and 16: Kinetic Theory of Matter, States of matter, and and thermodynamics, and gas laws. 1. The Kinetic

More information

NUMERICAL ANALYSIS OF THE EFFECTS OF WIND ON BUILDING STRUCTURES

NUMERICAL ANALYSIS OF THE EFFECTS OF WIND ON BUILDING STRUCTURES Vol. XX 2012 No. 4 28 34 J. ŠIMIČEK O. HUBOVÁ NUMERICAL ANALYSIS OF THE EFFECTS OF WIND ON BUILDING STRUCTURES Jozef ŠIMIČEK email: jozef.simicek@stuba.sk Research field: Statics and Dynamics Fluids mechanics

More information

Topic 3b: Kinetic Theory

Topic 3b: Kinetic Theory Topic 3b: Kinetic Theory What is temperature? We have developed some statistical language to simplify describing measurements on physical systems. When we measure the temperature of a system, what underlying

More information

Physics 9e/Cutnell. correlated to the. College Board AP Physics 1 Course Objectives

Physics 9e/Cutnell. correlated to the. College Board AP Physics 1 Course Objectives Physics 9e/Cutnell correlated to the College Board AP Physics 1 Course Objectives Big Idea 1: Objects and systems have properties such as mass and charge. Systems may have internal structure. Enduring

More information

Halliday, Resnick & Walker Chapter 13. Gravitation. Physics 1A PHYS1121 Professor Michael Burton

Halliday, Resnick & Walker Chapter 13. Gravitation. Physics 1A PHYS1121 Professor Michael Burton Halliday, Resnick & Walker Chapter 13 Gravitation Physics 1A PHYS1121 Professor Michael Burton II_A2: Planetary Orbits in the Solar System + Galaxy Interactions (You Tube) 21 seconds 13-1 Newton's Law

More information

Define the notations you are using properly. Present your arguments in details. Good luck!

Define the notations you are using properly. Present your arguments in details. Good luck! Umeå Universitet, Fysik Vitaly Bychkov Prov i fysik, Thermodynamics, 0-0-4, kl 9.00-5.00 jälpmedel: Students may use any book(s) including the textbook Thermal physics. Minor notes in the books are also

More information

Sound. References: L.D. Landau & E.M. Lifshitz: Fluid Mechanics, Chapter VIII F. Shu: The Physics of Astrophysics, Vol. 2, Gas Dynamics, Chapter 8

Sound. References: L.D. Landau & E.M. Lifshitz: Fluid Mechanics, Chapter VIII F. Shu: The Physics of Astrophysics, Vol. 2, Gas Dynamics, Chapter 8 References: Sound L.D. Landau & E.M. Lifshitz: Fluid Mechanics, Chapter VIII F. Shu: The Physics of Astrophysics, Vol., Gas Dynamics, Chapter 8 1 Speed of sound The phenomenon of sound waves is one that

More information

A. Kinetic Molecular Theory (KMT) = the idea that particles of matter are always in motion and that this motion has consequences.

A. Kinetic Molecular Theory (KMT) = the idea that particles of matter are always in motion and that this motion has consequences. I. MOLECULES IN MOTION: A. Kinetic Molecular Theory (KMT) = the idea that particles of matter are always in motion and that this motion has consequences. 1) theory developed in the late 19 th century to

More information

THE KINETIC THEORY OF GASES

THE KINETIC THEORY OF GASES Chapter 19: THE KINETIC THEORY OF GASES 1. Evidence that a gas consists mostly of empty space is the fact that: A. the density of a gas becomes much greater when it is liquefied B. gases exert pressure

More information

CBE 6333, R. Levicky 1 Review of Fluid Mechanics Terminology

CBE 6333, R. Levicky 1 Review of Fluid Mechanics Terminology CBE 6333, R. Levicky 1 Review of Fluid Mechanics Terminology The Continuum Hypothesis: We will regard macroscopic behavior of fluids as if the fluids are perfectly continuous in structure. In reality,

More information

KINETIC MOLECULAR THEORY OF MATTER

KINETIC MOLECULAR THEORY OF MATTER KINETIC MOLECULAR THEORY OF MATTER The kinetic-molecular theory is based on the idea that particles of matter are always in motion. The theory can be used to explain the properties of solids, liquids,

More information

momentum change per impact The average rate of change of momentum = Time interval between successive impacts 2m x 2l / x m x m x 2 / l P = l 2 P = l 3

momentum change per impact The average rate of change of momentum = Time interval between successive impacts 2m x 2l / x m x m x 2 / l P = l 2 P = l 3 Kinetic Molecular Theory This explains the Ideal Gas Pressure olume and Temperature behavior It s based on following ideas:. Any ordinary sized or macroscopic sample of gas contains large number of molecules.

More information

Fluids and Solids: Fundamentals

Fluids and Solids: Fundamentals Fluids and Solids: Fundamentals We normally recognize three states of matter: solid; liquid and gas. However, liquid and gas are both fluids: in contrast to solids they lack the ability to resist deformation.

More information

Halliday, Resnick & Walker Chapter 13. Gravitation. Physics 1A PHYS1121 Professor Michael Burton

Halliday, Resnick & Walker Chapter 13. Gravitation. Physics 1A PHYS1121 Professor Michael Burton Halliday, Resnick & Walker Chapter 13 Gravitation Physics 1A PHYS1121 Professor Michael Burton II_A2: Planetary Orbits in the Solar System + Galaxy Interactions (You Tube) 21 seconds 13-1 Newton's Law

More information

1 The basic equations of fluid dynamics

1 The basic equations of fluid dynamics 1 The basic equations of fluid dynamics The main task in fluid dynamics is to find the velocity field describing the flow in a given domain. To do this, one uses the basic equations of fluid flow, which

More information

Energy Transport. Focus on heat transfer. Heat Transfer Mechanisms: Conduction Radiation Convection (mass movement of fluids)

Energy Transport. Focus on heat transfer. Heat Transfer Mechanisms: Conduction Radiation Convection (mass movement of fluids) Energy Transport Focus on heat transfer Heat Transfer Mechanisms: Conduction Radiation Convection (mass movement of fluids) Conduction Conduction heat transfer occurs only when there is physical contact

More information

Chapter 15 Collision Theory

Chapter 15 Collision Theory Chapter 15 Collision Theory 151 Introduction 1 15 Reference Frames Relative and Velocities 1 151 Center of Mass Reference Frame 15 Relative Velocities 3 153 Characterizing Collisions 5 154 One-Dimensional

More information

Basic Equations, Boundary Conditions and Dimensionless Parameters

Basic Equations, Boundary Conditions and Dimensionless Parameters Chapter 2 Basic Equations, Boundary Conditions and Dimensionless Parameters In the foregoing chapter, many basic concepts related to the present investigation and the associated literature survey were

More information

Contents. Microfluidics - Jens Ducrée Physics: Navier-Stokes Equation 1

Contents. Microfluidics - Jens Ducrée Physics: Navier-Stokes Equation 1 Contents 1. Introduction 2. Fluids 3. Physics of Microfluidic Systems 4. Microfabrication Technologies 5. Flow Control 6. Micropumps 7. Sensors 8. Ink-Jet Technology 9. Liquid Handling 10.Microarrays 11.Microreactors

More information

Introduction to the Monte Carlo method

Introduction to the Monte Carlo method Some history Simple applications Radiation transport modelling Flux and Dose calculations Variance reduction Easy Monte Carlo Pioneers of the Monte Carlo Simulation Method: Stanisław Ulam (1909 1984) Stanislaw

More information

Kinetic Molecular Theory and Gas Laws

Kinetic Molecular Theory and Gas Laws Kinetic Molecular Theory and Gas Laws I. Handout: Unit Notes II. Modeling at the Atomic Scale I. In another unit you learned about the history of the atom and the different models people had of what the

More information

1. Fluids Mechanics and Fluid Properties. 1.1 Objectives of this section. 1.2 Fluids

1. Fluids Mechanics and Fluid Properties. 1.1 Objectives of this section. 1.2 Fluids 1. Fluids Mechanics and Fluid Properties What is fluid mechanics? As its name suggests it is the branch of applied mechanics concerned with the statics and dynamics of fluids - both liquids and gases.

More information

When the fluid velocity is zero, called the hydrostatic condition, the pressure variation is due only to the weight of the fluid.

When the fluid velocity is zero, called the hydrostatic condition, the pressure variation is due only to the weight of the fluid. Fluid Statics When the fluid velocity is zero, called the hydrostatic condition, the pressure variation is due only to the weight of the fluid. Consider a small wedge of fluid at rest of size Δx, Δz, Δs

More information

Chapter 12 - Liquids and Solids

Chapter 12 - Liquids and Solids Chapter 12 - Liquids and Solids 12-1 Liquids I. Properties of Liquids and the Kinetic Molecular Theory A. Fluids 1. Substances that can flow and therefore take the shape of their container B. Relative

More information

Lecture 3 Fluid Dynamics and Balance Equa6ons for Reac6ng Flows

Lecture 3 Fluid Dynamics and Balance Equa6ons for Reac6ng Flows Lecture 3 Fluid Dynamics and Balance Equa6ons for Reac6ng Flows 3.- 1 Basics: equations of continuum mechanics - balance equations for mass and momentum - balance equations for the energy and the chemical

More information

Lecture L14 - Variable Mass Systems: The Rocket Equation

Lecture L14 - Variable Mass Systems: The Rocket Equation J. Peraire, S. Widnall 16.07 Dynamics Fall 2008 Version 2.0 Lecture L14 - Variable Mass Systems: The Rocket Equation In this lecture, we consider the problem in which the mass of the body changes during

More information

State Newton's second law of motion for a particle, defining carefully each term used.

State Newton's second law of motion for a particle, defining carefully each term used. 5 Question 1. [Marks 20] An unmarked police car P is, travelling at the legal speed limit, v P, on a straight section of highway. At time t = 0, the police car is overtaken by a car C, which is speeding

More information

PHYSICAL QUANTITIES AND UNITS

PHYSICAL QUANTITIES AND UNITS 1 PHYSICAL QUANTITIES AND UNITS Introduction Physics is the study of matter, its motion and the interaction between matter. Physics involves analysis of physical quantities, the interaction between them

More information

Lecture 24 - Surface tension, viscous flow, thermodynamics

Lecture 24 - Surface tension, viscous flow, thermodynamics Lecture 24 - Surface tension, viscous flow, thermodynamics Surface tension, surface energy The atoms at the surface of a solid or liquid are not happy. Their bonding is less ideal than the bonding of atoms

More information

Mechanics 1: Conservation of Energy and Momentum

Mechanics 1: Conservation of Energy and Momentum Mechanics : Conservation of Energy and Momentum If a certain quantity associated with a system does not change in time. We say that it is conserved, and the system possesses a conservation law. Conservation

More information

Express Introductory Training in ANSYS Fluent Lecture 1 Introduction to the CFD Methodology

Express Introductory Training in ANSYS Fluent Lecture 1 Introduction to the CFD Methodology Express Introductory Training in ANSYS Fluent Lecture 1 Introduction to the CFD Methodology Dimitrios Sofialidis Technical Manager, SimTec Ltd. Mechanical Engineer, PhD PRACE Autumn School 2013 - Industry

More information

Study the following diagrams of the States of Matter. Label the names of the Changes of State between the different states.

Study the following diagrams of the States of Matter. Label the names of the Changes of State between the different states. Describe the strength of attractive forces between particles. Describe the amount of space between particles. Can the particles in this state be compressed? Do the particles in this state have a definite

More information

4. Introduction to Heat & Mass Transfer

4. Introduction to Heat & Mass Transfer 4. Introduction to Heat & Mass Transfer This section will cover the following concepts: A rudimentary introduction to mass transfer. Mass transfer from a molecular point of view. Fundamental similarity

More information

1. Degenerate Pressure

1. Degenerate Pressure . Degenerate Pressure We next consider a Fermion gas in quite a different context: the interior of a white dwarf star. Like other stars, white dwarfs have fully ionized plasma interiors. The positively

More information

Kinetic Theory & Ideal Gas

Kinetic Theory & Ideal Gas 1 of 6 Thermodynamics Summer 2006 Kinetic Theory & Ideal Gas The study of thermodynamics usually starts with the concepts of temperature and heat, and most people feel that the temperature of an object

More information

ME6130 An introduction to CFD 1-1

ME6130 An introduction to CFD 1-1 ME6130 An introduction to CFD 1-1 What is CFD? Computational fluid dynamics (CFD) is the science of predicting fluid flow, heat and mass transfer, chemical reactions, and related phenomena by solving numerically

More information

Fluid Mechanics: Static s Kinematics Dynamics Fluid

Fluid Mechanics: Static s Kinematics Dynamics Fluid Fluid Mechanics: Fluid mechanics may be defined as that branch of engineering science that deals with the behavior of fluid under the condition of rest and motion Fluid mechanics may be divided into three

More information

Lecture L22-2D Rigid Body Dynamics: Work and Energy

Lecture L22-2D Rigid Body Dynamics: Work and Energy J. Peraire, S. Widnall 6.07 Dynamics Fall 008 Version.0 Lecture L - D Rigid Body Dynamics: Work and Energy In this lecture, we will revisit the principle of work and energy introduced in lecture L-3 for

More information

Kinetic Theory: Atomic and Molecular Explanation of Pressure and Temperature

Kinetic Theory: Atomic and Molecular Explanation of Pressure and Temperature OpenStax-CNX module: m42217 1 Kinetic Theory: Atomic and Molecular Explanation of Pressure and Temperature OpenStax College This work is produced by OpenStax-CNX and licensed under the Creative Commons

More information

Heating & Cooling in Molecular Clouds

Heating & Cooling in Molecular Clouds Lecture 8: Cloud Stability Heating & Cooling in Molecular Clouds Balance of heating and cooling processes helps to set the temperature in the gas. This then sets the minimum internal pressure in a core

More information

PHYS-2010: General Physics I Course Lecture Notes Section XIII

PHYS-2010: General Physics I Course Lecture Notes Section XIII PHYS-2010: General Physics I Course Lecture Notes Section XIII Dr. Donald G. Luttermoser East Tennessee State University Edition 2.5 Abstract These class notes are designed for use of the instructor and

More information

Computational Fluid Dynamics (CFD) and Multiphase Flow Modelling. Associate Professor Britt M. Halvorsen (Dr. Ing) Amaranath S.

Computational Fluid Dynamics (CFD) and Multiphase Flow Modelling. Associate Professor Britt M. Halvorsen (Dr. Ing) Amaranath S. Computational Fluid Dynamics (CFD) and Multiphase Flow Modelling Associate Professor Britt M. Halvorsen (Dr. Ing) Amaranath S. Kumara (PhD Student), PO. Box 203, N-3901, N Porsgrunn, Norway What is CFD?

More information

Name Date Class STATES OF MATTER. SECTION 13.1 THE NATURE OF GASES (pages 385 389)

Name Date Class STATES OF MATTER. SECTION 13.1 THE NATURE OF GASES (pages 385 389) 13 STATES OF MATTER SECTION 13.1 THE NATURE OF GASES (pages 385 389) This section introduces the kinetic theory and describes how it applies to gases. It defines gas pressure and explains how temperature

More information

DIFFUSION IN SOLIDS. Materials often heat treated to improve properties. Atomic diffusion occurs during heat treatment

DIFFUSION IN SOLIDS. Materials often heat treated to improve properties. Atomic diffusion occurs during heat treatment DIFFUSION IN SOLIDS WHY STUDY DIFFUSION? Materials often heat treated to improve properties Atomic diffusion occurs during heat treatment Depending on situation higher or lower diffusion rates desired

More information

Physics 41 HW Set 1 Chapter 15

Physics 41 HW Set 1 Chapter 15 Physics 4 HW Set Chapter 5 Serway 8 th OC:, 4, 7 CQ: 4, 8 P: 4, 5, 8, 8, 0, 9,, 4, 9, 4, 5, 5 Discussion Problems:, 57, 59, 67, 74 OC CQ P: 4, 5, 8, 8, 0, 9,, 4, 9, 4, 5, 5 Discussion Problems:, 57, 59,

More information

Name Class Date. In the space provided, write the letter of the term or phrase that best completes each statement or best answers each question.

Name Class Date. In the space provided, write the letter of the term or phrase that best completes each statement or best answers each question. Assessment Chapter Test A Chapter: States of Matter In the space provided, write the letter of the term or phrase that best completes each statement or best answers each question. 1. The kinetic-molecular

More information

Temperature Measure of KE At the same temperature, heavier molecules have less speed Absolute Zero -273 o C 0 K

Temperature Measure of KE At the same temperature, heavier molecules have less speed Absolute Zero -273 o C 0 K Temperature Measure of KE At the same temperature, heavier molecules have less speed Absolute Zero -273 o C 0 K Kinetic Molecular Theory of Gases 1. Large number of atoms/molecules in random motion 2.

More information

TWO-DIMENSIONAL FINITE ELEMENT ANALYSIS OF FORCED CONVECTION FLOW AND HEAT TRANSFER IN A LAMINAR CHANNEL FLOW

TWO-DIMENSIONAL FINITE ELEMENT ANALYSIS OF FORCED CONVECTION FLOW AND HEAT TRANSFER IN A LAMINAR CHANNEL FLOW TWO-DIMENSIONAL FINITE ELEMENT ANALYSIS OF FORCED CONVECTION FLOW AND HEAT TRANSFER IN A LAMINAR CHANNEL FLOW Rajesh Khatri 1, 1 M.Tech Scholar, Department of Mechanical Engineering, S.A.T.I., vidisha

More information

THE IDEAL GAS LAW AND KINETIC THEORY

THE IDEAL GAS LAW AND KINETIC THEORY Chapter 14 he Ideal Gas Law and Kinetic heory Chapter 14 HE IDEAL GAS LAW AND KINEIC HEORY REIEW Kinetic molecular theory involves the study of matter, particularly gases, as very small particles in constant

More information

Multidisciplinary Analysis Tools for Orbit and Re-entry. G. Koppenwallner, HTG ; B. Fritsche; T. Lips, HTG

Multidisciplinary Analysis Tools for Orbit and Re-entry. G. Koppenwallner, HTG ; B. Fritsche; T. Lips, HTG Multidisciplinary Analysis Tools for Orbit and Re-entry G. Koppenwallner, HTG ; B. Fritsche; T. Lips, HTG ESTEC, Oct. 2006 Introduction The overview covers RAMSES, (Rarefied Aerodynamic Modelling System

More information

Lecture 6 - Boundary Conditions. Applied Computational Fluid Dynamics

Lecture 6 - Boundary Conditions. Applied Computational Fluid Dynamics Lecture 6 - Boundary Conditions Applied Computational Fluid Dynamics Instructor: André Bakker http://www.bakker.org André Bakker (2002-2006) Fluent Inc. (2002) 1 Outline Overview. Inlet and outlet boundaries.

More information

Newton s Laws of Motion

Newton s Laws of Motion Chapter 1. Newton s Laws of Motion Notes: Most of the material in this chapter is taken from Young and Freedman, Chapters 4 and 5 1.1 Forces and Interactions It was Isaac Newton who first introduced the

More information

Lecture 12. Physical Vapor Deposition: Evaporation and Sputtering Reading: Chapter 12. ECE 6450 - Dr. Alan Doolittle

Lecture 12. Physical Vapor Deposition: Evaporation and Sputtering Reading: Chapter 12. ECE 6450 - Dr. Alan Doolittle Lecture 12 Physical Vapor Deposition: Evaporation and Sputtering Reading: Chapter 12 Evaporation and Sputtering (Metalization) Evaporation For all devices, there is a need to go from semiconductor to metal.

More information

Introduction to COMSOL. The Navier-Stokes Equations

Introduction to COMSOL. The Navier-Stokes Equations Flow Between Parallel Plates Modified from the COMSOL ChE Library module rev 10/13/08 Modified by Robert P. Hesketh, Chemical Engineering, Rowan University Fall 2008 Introduction to COMSOL The following

More information

G U I D E T O A P P L I E D O R B I T A L M E C H A N I C S F O R K E R B A L S P A C E P R O G R A M

G U I D E T O A P P L I E D O R B I T A L M E C H A N I C S F O R K E R B A L S P A C E P R O G R A M G U I D E T O A P P L I E D O R B I T A L M E C H A N I C S F O R K E R B A L S P A C E P R O G R A M CONTENTS Foreword... 2 Forces... 3 Circular Orbits... 8 Energy... 10 Angular Momentum... 13 FOREWORD

More information

Physics Notes Class 11 CHAPTER 3 MOTION IN A STRAIGHT LINE

Physics Notes Class 11 CHAPTER 3 MOTION IN A STRAIGHT LINE 1 P a g e Motion Physics Notes Class 11 CHAPTER 3 MOTION IN A STRAIGHT LINE If an object changes its position with respect to its surroundings with time, then it is called in motion. Rest If an object

More information

Gas Laws. The kinetic theory of matter states that particles which make up all types of matter are in constant motion.

Gas Laws. The kinetic theory of matter states that particles which make up all types of matter are in constant motion. Name Period Gas Laws Kinetic energy is the energy of motion of molecules. Gas state of matter made up of tiny particles (atoms or molecules). Each atom or molecule is very far from other atoms or molecules.

More information

Customer Training Material. Lecture 2. Introduction to. Methodology ANSYS FLUENT. ANSYS, Inc. Proprietary 2010 ANSYS, Inc. All rights reserved.

Customer Training Material. Lecture 2. Introduction to. Methodology ANSYS FLUENT. ANSYS, Inc. Proprietary 2010 ANSYS, Inc. All rights reserved. Lecture 2 Introduction to CFD Methodology Introduction to ANSYS FLUENT L2-1 What is CFD? Computational Fluid Dynamics (CFD) is the science of predicting fluid flow, heat and mass transfer, chemical reactions,

More information

- momentum conservation equation ρ = ρf. These are equivalent to four scalar equations with four unknowns: - pressure p - velocity components

- momentum conservation equation ρ = ρf. These are equivalent to four scalar equations with four unknowns: - pressure p - velocity components J. Szantyr Lecture No. 14 The closed system of equations of the fluid mechanics The above presented equations form the closed system of the fluid mechanics equations, which may be employed for description

More information

4 Microscopic dynamics

4 Microscopic dynamics 4 Microscopic dynamics In this section we will look at the first model that people came up with when they started to model polymers from the microscopic level. It s called the Oldroyd B model. We will

More information

State Newton's second law of motion for a particle, defining carefully each term used.

State Newton's second law of motion for a particle, defining carefully each term used. 5 Question 1. [Marks 28] An unmarked police car P is, travelling at the legal speed limit, v P, on a straight section of highway. At time t = 0, the police car is overtaken by a car C, which is speeding

More information

Gases. States of Matter. Molecular Arrangement Solid Small Small Ordered Liquid Unity Unity Local Order Gas High Large Chaotic (random)

Gases. States of Matter. Molecular Arrangement Solid Small Small Ordered Liquid Unity Unity Local Order Gas High Large Chaotic (random) Gases States of Matter States of Matter Kinetic E (motion) Potential E(interaction) Distance Between (size) Molecular Arrangement Solid Small Small Ordered Liquid Unity Unity Local Order Gas High Large

More information

Chapter 28 Fluid Dynamics

Chapter 28 Fluid Dynamics Chapter 28 Fluid Dynamics 28.1 Ideal Fluids... 1 28.2 Velocity Vector Field... 1 28.3 Mass Continuity Equation... 3 28.4 Bernoulli s Principle... 4 28.5 Worked Examples: Bernoulli s Equation... 7 Example

More information

) and mass of each particle is m. We make an extremely small

) and mass of each particle is m. We make an extremely small Umeå Universitet, Fysik Vitaly Bychkov Prov i fysik, Thermodynamics, --6, kl 9.-5. Hjälpmedel: Students may use any book including the textbook Thermal physics. Present your solutions in details: it will

More information

Gases and Kinetic-Molecular Theory: Chapter 12. Chapter Outline. Chapter Outline

Gases and Kinetic-Molecular Theory: Chapter 12. Chapter Outline. Chapter Outline Gases and Kinetic-Molecular heory: Chapter Chapter Outline Comparison of Solids, Liquids, and Gases Composition of the Atmosphere and Some Common Properties of Gases Pressure Boyle s Law: he Volume-Pressure

More information

Blackbody radiation. Main Laws. Brightness temperature. 1. Concepts of a blackbody and thermodynamical equilibrium.

Blackbody radiation. Main Laws. Brightness temperature. 1. Concepts of a blackbody and thermodynamical equilibrium. Lecture 4 lackbody radiation. Main Laws. rightness temperature. Objectives: 1. Concepts of a blackbody, thermodynamical equilibrium, and local thermodynamical equilibrium.. Main laws: lackbody emission:

More information

HEAT AND MASS TRANSFER

HEAT AND MASS TRANSFER MEL242 HEAT AND MASS TRANSFER Prabal Talukdar Associate Professor Department of Mechanical Engineering g IIT Delhi prabal@mech.iitd.ac.in MECH/IITD Course Coordinator: Dr. Prabal Talukdar Room No: III,

More information

10.7 Kinetic Molecular Theory. 10.7 Kinetic Molecular Theory. Kinetic Molecular Theory. Kinetic Molecular Theory. Kinetic Molecular Theory

10.7 Kinetic Molecular Theory. 10.7 Kinetic Molecular Theory. Kinetic Molecular Theory. Kinetic Molecular Theory. Kinetic Molecular Theory The first scheduled quiz will be given next Tuesday during Lecture. It will last 5 minutes. Bring pencil, calculator, and your book. The coverage will be pp 364-44, i.e. Sections 0.0 through.4. 0.7 Theory

More information

1.4.6-1.4.8 Gas Laws. Heat and Temperature

1.4.6-1.4.8 Gas Laws. Heat and Temperature 1.4.6-1.4.8 Gas Laws Heat and Temperature Often the concepts of heat and temperature are thought to be the same, but they are not. Perhaps the reason the two are incorrectly thought to be the same is because

More information

ENERGY CONSERVATION The First Law of Thermodynamics and the Work/Kinetic-Energy Theorem

ENERGY CONSERVATION The First Law of Thermodynamics and the Work/Kinetic-Energy Theorem PH-211 A. La Rosa ENERGY CONSERVATION The irst Law of Thermodynamics and the Work/Kinetic-Energy Theorem ENERGY TRANSER of ENERGY Heat-transfer Q Macroscopic external Work W done on a system ENERGY CONSERVATION

More information

Physics Notes Class 11 CHAPTER 6 WORK, ENERGY AND POWER

Physics Notes Class 11 CHAPTER 6 WORK, ENERGY AND POWER 1 P a g e Work Physics Notes Class 11 CHAPTER 6 WORK, ENERGY AND POWER When a force acts on an object and the object actually moves in the direction of force, then the work is said to be done by the force.

More information

7. DYNAMIC LIGHT SCATTERING 7.1 First order temporal autocorrelation function.

7. DYNAMIC LIGHT SCATTERING 7.1 First order temporal autocorrelation function. 7. DYNAMIC LIGHT SCATTERING 7. First order temporal autocorrelation function. Dynamic light scattering (DLS) studies the properties of inhomogeneous and dynamic media. A generic situation is illustrated

More information

Conservation of Momentum and Energy

Conservation of Momentum and Energy Conservation of Momentum and Energy OBJECTIVES to investigate simple elastic and inelastic collisions in one dimension to study the conservation of momentum and energy phenomena EQUIPMENT horizontal dynamics

More information

Ch 2 Properties of Fluids - II. Ideal Fluids. Real Fluids. Viscosity (1) Viscosity (3) Viscosity (2)

Ch 2 Properties of Fluids - II. Ideal Fluids. Real Fluids. Viscosity (1) Viscosity (3) Viscosity (2) Ch 2 Properties of Fluids - II Ideal Fluids 1 Prepared for CEE 3500 CEE Fluid Mechanics by Gilberto E. Urroz, August 2005 2 Ideal fluid: a fluid with no friction Also referred to as an inviscid (zero viscosity)

More information

Entropy and the Kinetic Theory: the Molecular Picture

Entropy and the Kinetic Theory: the Molecular Picture previous index next Entropy and the Kinetic Theory: the Molecular Picture Michael Fowler 7/15/08 Searching for a Molecular Description of Entropy Clausius introduced entropy as a new thermodynamic variable

More information

Chapter 4 Atmospheric Pressure and Wind

Chapter 4 Atmospheric Pressure and Wind Chapter 4 Atmospheric Pressure and Wind Understanding Weather and Climate Aguado and Burt Pressure Pressure amount of force exerted per unit of surface area. Pressure always decreases vertically with height

More information

CONVERGE Features, Capabilities and Applications

CONVERGE Features, Capabilities and Applications CONVERGE Features, Capabilities and Applications CONVERGE CONVERGE The industry leading CFD code for complex geometries with moving boundaries. Start using CONVERGE and never make a CFD mesh again. CONVERGE

More information

CFD SIMULATION OF SDHW STORAGE TANK WITH AND WITHOUT HEATER

CFD SIMULATION OF SDHW STORAGE TANK WITH AND WITHOUT HEATER International Journal of Advancements in Research & Technology, Volume 1, Issue2, July-2012 1 CFD SIMULATION OF SDHW STORAGE TANK WITH AND WITHOUT HEATER ABSTRACT (1) Mr. Mainak Bhaumik M.E. (Thermal Engg.)

More information

Blackbody radiation derivation of Planck s radiation low

Blackbody radiation derivation of Planck s radiation low Blackbody radiation derivation of Planck s radiation low 1 Classical theories of Lorentz and Debye: Lorentz (oscillator model): Electrons and ions of matter were treated as a simple harmonic oscillators

More information

Reaction Rates and Chemical Kinetics. Factors Affecting Reaction Rate [O 2. CHAPTER 13 Page 1

Reaction Rates and Chemical Kinetics. Factors Affecting Reaction Rate [O 2. CHAPTER 13 Page 1 CHAPTER 13 Page 1 Reaction Rates and Chemical Kinetics Several factors affect the rate at which a reaction occurs. Some reactions are instantaneous while others are extremely slow. Whether a commercial

More information

Kinetic Energy (A) stays the same stays the same (B) increases increases (C) stays the same increases (D) increases stays the same.

Kinetic Energy (A) stays the same stays the same (B) increases increases (C) stays the same increases (D) increases stays the same. 1. A cart full of water travels horizontally on a frictionless track with initial velocity v. As shown in the diagram, in the back wall of the cart there is a small opening near the bottom of the wall

More information