Fluid Animation. Christopher Batty November 17, 2011

Size: px
Start display at page:

Download "Fluid Animation. Christopher Batty November 17, 2011"

Transcription

1 Fluid Animation Christopher Batty November 17, 2011

2 What distinguishes fluids?

3 What distinguishes fluids? No preferred shape Always flows when force is applied Deforms to fit its container Internal forces depend on velocities, not displacements Watch fluid simulation clips

4 Basic Theory

5 Eulerian vs. Lagrangian Lagrangian: Point of reference moves with the material. Eulerian: Point of reference is stationary. e.g. Weather balloon (Lagrangian) vs. weather station on the ground (Eulerian)

6 Eulerian vs. Lagrangian Consider an evolving temperature field. Lagrangian: Set of moving particles, each with a temperature value.

7 Eulerian vs. Lagrangian Consider an evolving temperature field. Eulerian: A fixed grid of temperature values, that temperature flows through.

8 Relating Eulerian and Lagrangian Consider the temperature T(x, t) at a point following a given path, x(t). x(t 0 ) x(t 1 ) x(t now ) Two ways temperature changes: 1. Heating/cooling occurs at the current point. 2. Following the path, the point moves to a cooler/warmer location.

9 Mathematically: Time derivatives D Dt T x t, t = T t + T x x t Chain rule! = T t = T t + T x t + u T Definition of Choose x t = u

10 Material Derivative This is called the material derivative, and denoted D Dt. Change at a point moving with the velocity field. Change due to movement. DT Dt = T t + u T Change at the current (fixed) point.

11 Advection To track a quantity T simply moving (passively) through a velocity field: DT Dt = 0 or equivalently T t + u T = 0 This is the advection equation. Think of colored dye or massless particles drifting around in fluid. Watch dye in fluid clip

12 Equations of Motion For general materials, we have Newton s second law: F = ma. Specialized for fluids: Navier-Stokes Equations

13 Navier-Stokes Density Acceleration = Sum of Forces ρ Du Dt = i F i Expanding the material derivative ρ u t = ρ u u + F i i

14 What are the forces on a fluid? Primarily for now: Pressure Viscosity Simple external forces (e.g. gravity, buoyancy, user forces) Also: Surface tension Coriolis Possibilities for more exotic fluid types: Elasticity (e.g. silly putty) Shear thickening / thinning (e.g. oobleck, ketchup) Electromagnetic forces Sky s the limit... Watch oobleck clip

15 In full ρ u t = ρ u u + F i i Change in velocity at a fixed point Advection Forces (pressure, viscosity gravity, )

16 Operator splitting Break the equation into steps: 1. Advection: ρ u t = ρ u u 2. Pressure: ρ u t = F pressure 3. Viscosity: ρ u t = F viscosity 4. External: ρ u t = F other

17 1. Advection

18 Advection Previously, we considered advection of a passive scalar quantity, T, by velocity u. T t = u T In Navier-Stokes we saw: u t = u u Velocity u is advected by itself!

19 Advection i.e., The scalar components u, v of the vector u are each advected in the same way. We can reuse the same numerical method.

20 2. Pressure

21 Pressure What does pressure do? Enforces incompressibility. Typical fluids (mostly) do not compress. Exceptions: high velocity, high pressure,

22 Incompressibility Compressible velocity field Incompressible velocity field

23 Incompressibility Intuitively, net flow into/out of a given region is zero (no sinks/sources). Integrate the flow across the boundary of a closed region: u n Ω = 0 n

24 Incompressibility u n Ω By divergence theorem: = 0 u = 0 But this is true for any region, so u = 0 everywhere.

25 Pressure How does pressure enter in? Pressure is the force required to ensure that u = 0. Pressure force has the following form: F p = p

26 Helmholtz-Hodge Decomposition Input Velocity field Curl-Free (irrotational) Divergence-Free (incompressible) = + u = p + φ u old = F pressure + u new

27 Aside: Pressure as Lagrange Multiplier Interpret as an optimization: Find the closest u new to u old where u new = 0 min u new u new u old s. t. u new = 0 A Lagrange multiplier to enforce the constraint is exactly pressure.

28 3. Viscosity

29 Viscosity What characterizes a viscous liquid? Thick, damped behaviour Higher resistance to flow Watch viscous honey clip

30 Viscosity Loss of energy due to internal friction between molecules moving at different velocities. Interactions between molecules in different layers causes shear stress that acts to oppose relative motion. causes an exchange of momentum

31 Viscosity Loss of energy due to internal friction between molecules moving at different velocities. Interactions between molecules in different layers causes shear stress that acts to oppose relative motion. causes an exchange of momentum

32 Viscosity Loss of energy due to internal friction between molecules moving at different velocities. Interactions between molecules in different layers causes shear stress that acts to oppose relative motion. causes an exchange of momentum

33 Viscosity Loss of energy due to internal friction between molecules moving at different velocities. Interactions between molecules in different layers causes shear stress that acts to oppose relative motion. causes an exchange of momentum

34 Viscosity Imagine fluid particles with general velocities. Each particle interacts with nearby neighbours, exchanging momentum.

35 Viscosity Amount of momentum exchanged is proportional to: Velocity gradient, u. Viscosity coefficient, μ For any closed region, net in/out flow of momentum: Ω μ u n = μ u So the viscosity force is: F viscosity = μ u

36 Viscosity The end result is a smoothing of the velocity. This is exactly the action of the Laplacian operator,. For scalar quantities, the same operator is used to model diffusion.

37 4. External Forces

38 External Forces Any other forces you may want. Simplest is gravity: F g = ρg for g = (0, 9.81) Buoyancy models are similar, e.g., F b = β(t current T ref )g

39 Numerical Methods

40 1. Advection

41 Advection of a Scalar First, we ll consider advecting a scalar quantity, φ. temperature, color, smoke density, The grid stores φ and u.

42 Eulerian Approximate derivatives with finite differences. φ + u φ = 0 t FTCS = Forward Time, Centered Space: φ n+1 n i φ i + u φ i+1 n n φ i 1 = 0 t 2 x Unconditionally Unstable! Lax: φ i n+1 (φ i+1 n + φ i 1 n )/2 t + u φ i+1 n φ i 1 n 2 x = 0 Conditionally Stable! Many possible methods, stability can be a challenge.

43 Lagrangian Advect data forward from grid points by integrating position according to grid velocity.? Problem: New data position doesn t necessarily land on a grid point.

44 Semi-Lagrangian Look backwards in time from grid points, to see where data is coming from. Interpolate data at previous time.

45 Semi-Lagrangian - Details 1. Determine velocity u i,j at grid point,. 2. Integrate position for a timestep of t. e.g. x back = x i,j tu i,j 3. Interpolate φ at x back, call it φ back. 4. Assign φ i,j = φ back for the next time. Unconditionally stable!

46 Advection of Velocity This is great for scalars. What about velocity advection? u t = u u Same method: Trace back with current velocity Interpolate velocity (component) at that point Assign it to the grid point at the new time. Caution: Do not overwrite the velocity field you re using to trace back!

47 2. Pressure

48 Input Velocity field Recall Helmholtz-Hodge Decomposition Curl-Free (irrotational) Divergence-Free (incompressible) = + u = p + φ u old = F pressure + u new

49 Pressure Projection - Derivation (1) ρ u = p and (2) u = 0 t Discretize (1) in time u new = u old t ρ p Then plug into (2) u old t ρ p = 0

50 Pressure Projection Implementation: 1) Solve a linear system for p: t ρ p = u old 2) Update grid velocity with: u new = u old t ρ p

51 Implementation t ρ p = u old Discretize with finite differences: u i+1 u i p i+1 p i p i 1 e.g., in 1D: t ρ p i+1 p i x p i p i 1 x x = u i+1 old u i old x

52 Solid Boundary Conditions u n Free Slip: u new n = 0 52

53 Staggered vs. Non-staggered Two choices for grids: Velocity and pressure co-located p i+1 p i p i 1 u i+1 u i u i 1 Velocity and pressure staggered p i+1 u i+1 p i u i p i 1

54 Why prefer staggered? Finite differences line up nicely. u and p match, p and u match u i+1 u i p i+1 p i p i 1 which improves stability!

55 3. Viscosity

56 Viscosity PDE: ρ u t = μ u Use finite differences. Discretized in time: u new = u old + tμ ρ u

57 Viscosity Time Integration u new = u old + tμ ρ u Explicit integration, let u be u old : Just estimate tμ ρ u old Add to current u. Very unstable. Implicit integration, let u be u new : Stable for high viscosities. Need to solve a system of equations.

58 Viscosity Implicit Integration Solve for u new : u new tμ ρ u new = u old Apply separately for each velocity component. e.g. in 1D: u i tμ ρ u i+1 u i+1 u i x u i u i u i 1 x x u i 1 = u i old

59 Solid Boundary Conditions No-Slip: u new = 0 Watch no-slip clip 59

60 4. External Forces

61 Gravity Discretized form is: u new = u old + tg Just add a downward acceleration to each velocity, scaled by timestep.

62 Gravity Note: in a closed fluid-filled container, gravity (alone) won t do anything! Incompressibility cancels it out. (Assuming constant density) Start After gravity step After pressure step

63 Simple Buoyancy Look up T current at grid point, increment velocity based on difference from a reference velocity. u new = u old + tβ T current T ref g β dictates the strength of the buoyancy force. See paper for a more elaborate model: Visual simulation of smoke, 2001.

64 User Forces Add whatever additional forces we want, such as: near the mouse when the user clicks Paddle forces in Plasma Pong Watch clip

65 Ordering of Steps Order turns out to be important. Why? 1) Incompressibility is not guaranteed at intermediate steps 2) Advecting with a compressible field causes volume/material loss or gain!

66 Ordering of Steps Consider advection in this field: Best ordering 1) Advection 2) Viscosity 3) Add Forces 4) Make incompressible (Pressure)

67 Useful References Robert Bridson s SIGGRAPH 2007 Fluid Course notes: Stable Fluids [Stam 1999] Real-Time Stable Fluid Dynamics for Games [Stam, 2003]

68 Liquids

69 Liquids What s missing so far? We need: A surface representation Boundary conditions at the surface

70 The Big Picture Velocity Solver Advect Velocities Add Viscosity Add Gravity Project Velocities to be Incompressible

71 What about liquids? Velocity Solver Advect Velocities Add Viscosity Surface Tracker Add Gravity Project Velocities to be Incompressible

72 Surface Tracker Given: liquid surface geometry, velocity field, timestep Compute: new surface geometry by advection. T n u n T n+1

73 Surface Tracker Ideally: Efficient Accurate Handles merging/splitting (topology changes) Conserves volume Retains small features Smooth surface for rendering Provides convenient geometric operations Easy to implement Very hard (impossible?) to do all of these at once.

74 Surface Tracking Options 1. Particles 2. Level sets 3. Volume-of-fluid (VOF) 4. Triangle meshes 5. Hybrids (many of these)

75 Particles [Zhu & Bridson 2005]

76 Particles Perform passive Lagrangian advection on each particle. For rendering, need to reconstruct a surface.

77 Level sets [Losasso et al. 2004]

78 Level sets Each grid point stores signed distance to the surface (inside <= 0, outside > 0). Surface is interpolated zero isocontour. > 0 <= 0

79 Volume of fluid [Mullen et al 2007]

80 Volume-Of-Fluid Each cell stores fraction f ϵ 0,1 indicating how empty/full it is. Surface is transition region, f

81 Meshes [Brochu et al 2010]

82 Meshes Store a triangle mesh. Advect its vertices, and correct for collisions.

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

Modeling, Simulating and Rendering Fluids. Thanks to Ron Fediw et al, Jos Stam, Henrik Jensen, Ryan

Modeling, Simulating and Rendering Fluids. Thanks to Ron Fediw et al, Jos Stam, Henrik Jensen, Ryan Modeling, Simulating and Rendering Fluids Thanks to Ron Fediw et al, Jos Stam, Henrik Jensen, Ryan Applications Mostly Hollywood Shrek Antz Terminator 3 Many others Games Engineering Animating Fluids is

More information

PDE Solvers for Fluid Flow

PDE Solvers for Fluid Flow PDE Solvers for Fluid Flow issues and algorithms for the Streaming Supercomputer Eran Guendelman February 5, 2002 Topics Equations for incompressible fluid flow 3 model PDEs: Hyperbolic, Elliptic, Parabolic

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

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids Fluid dynamics Math background Physics Simulation Related phenomena Frontiers in graphics Rigid fluids Fields Domain Ω R2 Scalar field f :Ω R Vector field f : Ω R2 Types of derivatives Derivatives measure

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

Dan s Morris s Notes on Stable Fluids (Jos Stam, SIGGRAPH 1999)

Dan s Morris s Notes on Stable Fluids (Jos Stam, SIGGRAPH 1999) Dan s Morris s Notes on Stable Fluids (Jos Stam, SIGGRAPH 1999) This is intended to be a detailed by fairly-low-math explanation of Stam s Stable Fluids, one of the key papers in a recent series of advances

More information

Physics-Based Animation

Physics-Based Animation CSCI 5980/8980: Special Topics in Computer Science Physics-Based Animation 13 Fluid simulation with grids October 20, 2015 Today Presentation schedule Fluid simulation with grids Course feedback survey

More information

( ) Notes. Fluid mechanics. Inviscid Euler model. Lagrangian viewpoint. " = " x,t,#, #

( ) Notes. Fluid mechanics. Inviscid Euler model. Lagrangian viewpoint.  =  x,t,#, # Notes Assignment 4 due today (when I check email tomorrow morning) Don t be afraid to make assumptions, approximate quantities, In particular, method for computing time step bound (look at max eigenvalue

More information

Notes. Multi-Dimensional Plasticity. Yielding. Multi-Dimensional Yield criteria. (so rest state includes plastic strain): #=#(!

Notes. Multi-Dimensional Plasticity. Yielding. Multi-Dimensional Yield criteria. (so rest state includes plastic strain): #=#(! Notes Multi-Dimensional Plasticity! I am back, but still catching up! Assignment is due today (or next time I!m in the dept following today)! Final project proposals: I haven!t sorted through my email,

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

Pressure corrected SPH for fluid animation

Pressure corrected SPH for fluid animation Pressure corrected SPH for fluid animation Kai Bao, Hui Zhang, Lili Zheng and Enhua Wu Analyzed by Po-Ram Kim 2 March 2010 Abstract We present pressure scheme for the SPH for fluid animation In conventional

More information

Chapter 5. The Differential Forms of the Fundamental Laws

Chapter 5. The Differential Forms of the Fundamental Laws Chapter 5 The Differential Forms of the Fundamental Laws 1 5.1 Introduction Two primary methods in deriving the differential forms of fundamental laws: Gauss s Theorem: Allows area integrals of the equations

More information

Conservation of Mass. Computational Fluid Dynamics. The Equations Governing Fluid Motion

Conservation of Mass. Computational Fluid Dynamics. The Equations Governing Fluid Motion http://www.nd.edu/~gtryggva/cfd-course/ http://www.nd.edu/~gtryggva/cfd-course/ Computational Fluid Dynamics Lecture 4 January 30, 2017 The Equations Governing Fluid Motion Grétar Tryggvason Outline Derivation

More information

Numerical methods for the Navier- Stokes equations

Numerical methods for the Navier- Stokes equations Numerical methods for the Navier- Stokes equations Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Dec 6, 2012 Note:

More information

2 Equations of Motion

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

More information

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

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

Getting started: CFD notation

Getting started: CFD notation PDE of p-th order Getting started: CFD notation f ( u,x, t, u x 1,..., u x n, u, 2 u x 1 x 2,..., p u p ) = 0 scalar unknowns u = u(x, t), x R n, t R, n = 1,2,3 vector unknowns v = v(x, t), v R m, m =

More information

fluid mechanics as a prominent discipline of application for numerical

fluid mechanics as a prominent discipline of application for numerical 1. fluid mechanics as a prominent discipline of application for numerical simulations: experimental fluid mechanics: wind tunnel studies, laser Doppler anemometry, hot wire techniques,... theoretical fluid

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

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

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

EULERIAN DERIVATIONS OF NON-INERTIAL NAVIER-STOKES EQUATIONS

EULERIAN DERIVATIONS OF NON-INERTIAL NAVIER-STOKES EQUATIONS EULERIAN DERIVATIONS OF NON-INERTIAL NAVIER-STOKES EQUATIONS ML Combrinck, LN Dala Flamengro, a div of Armscor SOC Ltd & University of Pretoria, Council of Scientific and Industrial Research & University

More information

A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation

A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation S. Bordère a and J.-P. Caltagirone b a. CNRS, Univ. Bordeaux, ICMCB,

More information

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics Diffusion / Parabolic Equations Summary of PDEs (so far...) Hyperbolic Think: advection Real, finite speed(s) at which information propagates carries changes in the solution Second-order explicit methods

More information

A Study on Numerical Solution to the Incompressible Navier-Stokes Equation

A Study on Numerical Solution to the Incompressible Navier-Stokes Equation A Study on Numerical Solution to the Incompressible Navier-Stokes Equation Zipeng Zhao May 2014 1 Introduction 1.1 Motivation One of the most important applications of finite differences lies in the field

More information

Conservation of mass. Continuum Mechanics. Conservation of Momentum. Cauchy s Fundamental Postulate. # f body

Conservation of mass. Continuum Mechanics. Conservation of Momentum. Cauchy s Fundamental Postulate. # f body Continuum Mechanics We ll stick with the Lagrangian viewpoint for now Let s look at a deformable object World space: points x in the object as we see it Object space (or rest pose): points p in some reference

More information

Fluid Dynamics. Part 2. Massimo Ricotti. University of Maryland. Fluid Dynamics p.1/17

Fluid Dynamics. Part 2. Massimo Ricotti. University of Maryland. Fluid Dynamics p.1/17 Fluid Dynamics p.1/17 Fluid Dynamics Part 2 Massimo Ricotti ricotti@astro.umd.edu University of Maryland Fluid Dynamics p.2/17 Schemes Based on Flux-conservative Form By their very nature, the fluid equations

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

Particle Systems. CSE169: Computer Animation Instructor: Steve Rotenberg UCSD, Winter 2017

Particle Systems. CSE169: Computer Animation Instructor: Steve Rotenberg UCSD, Winter 2017 Particle Systems CSE169: Computer Animation Instructor: Steve Rotenberg UCSD, Winter 2017 Particle Systems Particle systems have been used extensively in computer animation and special effects since their

More information

Simulation in Computer Graphics Elastic Solids. Matthias Teschner

Simulation in Computer Graphics Elastic Solids. Matthias Teschner Simulation in Computer Graphics Elastic Solids Matthias Teschner Outline Introduction Elastic forces Miscellaneous Collision handling Visualization University of Freiburg Computer Science Department 2

More information

Math (P)Review Part II:

Math (P)Review Part II: Math (P)Review Part II: Vector Calculus Computer Graphics Assignment 0.5 (Out today!) Same story as last homework; second part on vector calculus. Slightly fewer questions Last Time: Linear Algebra Touched

More information

Entropy generation and transport

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

More information

Chapter 9: Differential Analysis

Chapter 9: Differential Analysis 9-1 Introduction 9-2 Conservation of Mass 9-3 The Stream Function 9-4 Conservation of Linear Momentum 9-5 Navier Stokes Equation 9-6 Differential Analysis Problems Recall 9-1 Introduction (1) Chap 5: Control

More information

CSCI1950V Project 4 : Smoothed Particle Hydrodynamics

CSCI1950V Project 4 : Smoothed Particle Hydrodynamics CSCI1950V Project 4 : Smoothed Particle Hydrodynamics Due Date : Midnight, Friday March 23 1 Background For this project you will implement a uid simulation using Smoothed Particle Hydrodynamics (SPH).

More information

Chapter 9: Differential Analysis of Fluid Flow

Chapter 9: Differential Analysis of Fluid Flow of Fluid Flow Objectives 1. Understand how the differential equations of mass and momentum conservation are derived. 2. Calculate the stream function and pressure field, and plot streamlines for a known

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

Particle-based Fluids

Particle-based Fluids Particle-based Fluids Particle Fluids Spatial Discretization Fluid is discretized using particles 3 Particles = Molecules? Particle approaches: Molecular Dynamics: relates each particle to one molecule

More information

Chapter 4: Fluid Kinematics

Chapter 4: Fluid Kinematics Overview Fluid kinematics deals with the motion of fluids without considering the forces and moments which create the motion. Items discussed in this Chapter. Material derivative and its relationship to

More information

Fluid equations, magnetohydrodynamics

Fluid equations, magnetohydrodynamics Fluid equations, magnetohydrodynamics Multi-fluid theory Equation of state Single-fluid theory Generalised Ohm s law Magnetic tension and plasma beta Stationarity and equilibria Validity of magnetohydrodynamics

More information

The Shallow Water Equations

The Shallow Water Equations If you have not already done so, you are strongly encouraged to read the companion file on the non-divergent barotropic vorticity equation, before proceeding to this shallow water case. We do not repeat

More information

Lecture 1: Introduction to Linear and Non-Linear Waves

Lecture 1: Introduction to Linear and Non-Linear Waves Lecture 1: Introduction to Linear and Non-Linear Waves Lecturer: Harvey Segur. Write-up: Michael Bates June 15, 2009 1 Introduction to Water Waves 1.1 Motivation and Basic Properties There are many types

More information

MAE 3130: Fluid Mechanics Lecture 7: Differential Analysis/Part 1 Spring Dr. Jason Roney Mechanical and Aerospace Engineering

MAE 3130: Fluid Mechanics Lecture 7: Differential Analysis/Part 1 Spring Dr. Jason Roney Mechanical and Aerospace Engineering MAE 3130: Fluid Mechanics Lecture 7: Differential Analysis/Part 1 Spring 2003 Dr. Jason Roney Mechanical and Aerospace Engineering Outline Introduction Kinematics Review Conservation of Mass Stream Function

More information

Simulation of Particulate Solids Processing Using Discrete Element Method Oleh Baran

Simulation of Particulate Solids Processing Using Discrete Element Method Oleh Baran Simulation of Particulate Solids Processing Using Discrete Element Method Oleh Baran Outline DEM overview DEM capabilities in STAR-CCM+ Particle types and injectors Contact physics Coupling to fluid flow

More information

1/18/2011. Conservation of Momentum Conservation of Mass Conservation of Energy Scaling Analysis ESS227 Prof. Jin-Yi Yu

1/18/2011. Conservation of Momentum Conservation of Mass Conservation of Energy Scaling Analysis ESS227 Prof. Jin-Yi Yu Lecture 2: Basic Conservation Laws Conservation Law of Momentum Newton s 2 nd Law of Momentum = absolute velocity viewed in an inertial system = rate of change of Ua following the motion in an inertial

More information

CS 542G: The Poisson Problem, Finite Differences

CS 542G: The Poisson Problem, Finite Differences CS 542G: The Poisson Problem, Finite Differences Robert Bridson November 10, 2008 1 The Poisson Problem At the end last time, we noticed that the gravitational potential has a zero Laplacian except at

More information

Navier-Stokes Equation: Principle of Conservation of Momentum

Navier-Stokes Equation: Principle of Conservation of Momentum Navier-tokes Equation: Principle of Conservation of Momentum R. hankar ubramanian Department of Chemical and Biomolecular Engineering Clarkson University Newton formulated the principle of conservation

More information

From the last time, we ended with an expression for the energy equation. u = ρg u + (τ u) q (9.1)

From the last time, we ended with an expression for the energy equation. u = ρg u + (τ u) q (9.1) Lecture 9 9. Administration None. 9. Continuation of energy equation From the last time, we ended with an expression for the energy equation ρ D (e + ) u = ρg u + (τ u) q (9.) Where ρg u changes in potential

More information

CHAPTER 8 ENTROPY GENERATION AND TRANSPORT

CHAPTER 8 ENTROPY GENERATION AND TRANSPORT CHAPTER 8 ENTROPY GENERATION AND TRANSPORT 8.1 CONVECTIVE FORM OF THE GIBBS EQUATION In this chapter we will address two questions. 1) How is Gibbs equation related to the energy conservation equation?

More information

Advection / Hyperbolic PDEs. PHY 604: Computational Methods in Physics and Astrophysics II

Advection / Hyperbolic PDEs. PHY 604: Computational Methods in Physics and Astrophysics II Advection / Hyperbolic PDEs Notes In addition to the slides and code examples, my notes on PDEs with the finite-volume method are up online: https://github.com/open-astrophysics-bookshelf/numerical_exercises

More information

Introduction to Fluid Dynamics

Introduction to Fluid Dynamics Introduction to Fluid Dynamics Roger K. Smith Skript - auf englisch! Umsonst im Internet http://www.meteo.physik.uni-muenchen.de Wählen: Lehre Manuskripte Download User Name: meteo Password: download Aim

More information

Control Volume. Dynamics and Kinematics. Basic Conservation Laws. Lecture 1: Introduction and Review 1/24/2017

Control Volume. Dynamics and Kinematics. Basic Conservation Laws. Lecture 1: Introduction and Review 1/24/2017 Lecture 1: Introduction and Review Dynamics and Kinematics Kinematics: The term kinematics means motion. Kinematics is the study of motion without regard for the cause. Dynamics: On the other hand, dynamics

More information

Lecture 1: Introduction and Review

Lecture 1: Introduction and Review Lecture 1: Introduction and Review Review of fundamental mathematical tools Fundamental and apparent forces Dynamics and Kinematics Kinematics: The term kinematics means motion. Kinematics is the study

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

.u= 0 ρ( u t +(u. )u)= ρ g p+.[µ( u+ t u)]

.u= 0 ρ( u t +(u. )u)= ρ g p+.[µ( u+ t u)] THETIS is a numerical simulation tool developed by University of Bordeaux. It is a versatile code to solve different problems: fluid flows, heat transfers, scalar transports or porous mediums. The potential

More information

Physically Based Simulations (on the GPU)

Physically Based Simulations (on the GPU) Physically Based Simulations (on the GPU) (some material from slides of Mark Harris) CS535 Fall 2014 Daniel G. Aliaga Department of Computer Science Purdue University Simulating the world Floating point

More information

Continuum Mechanics Lecture 5 Ideal fluids

Continuum Mechanics Lecture 5 Ideal fluids Continuum Mechanics Lecture 5 Ideal fluids Prof. http://www.itp.uzh.ch/~teyssier Outline - Helmholtz decomposition - Divergence and curl theorem - Kelvin s circulation theorem - The vorticity equation

More information

Fluid Mechanics 3502 Day 1, Spring 2018

Fluid Mechanics 3502 Day 1, Spring 2018 Instructor Fluid Mechanics 3502 Day 1, Spring 2018 Dr. Michele Guala, Civil Eng. Department UMN Office hours: (Tue -?) CEGE 162 9:30-10:30? Tue Thu CEGE phone (612) 626-7843 (Mon,Wed,Fr) SAFL, 2 third

More information

Probability density function (PDF) methods 1,2 belong to the broader family of statistical approaches

Probability density function (PDF) methods 1,2 belong to the broader family of statistical approaches Joint probability density function modeling of velocity and scalar in turbulence with unstructured grids arxiv:6.59v [physics.flu-dyn] Jun J. Bakosi, P. Franzese and Z. Boybeyi George Mason University,

More information

ESS314. Basics of Geophysical Fluid Dynamics by John Booker and Gerard Roe. Conservation Laws

ESS314. Basics of Geophysical Fluid Dynamics by John Booker and Gerard Roe. Conservation Laws ESS314 Basics of Geophysical Fluid Dynamics by John Booker and Gerard Roe Conservation Laws The big differences between fluids and other forms of matter are that they are continuous and they deform internally

More information

Review of fluid dynamics

Review of fluid dynamics Chapter 2 Review of fluid dynamics 2.1 Preliminaries ome basic concepts: A fluid is a substance that deforms continuously under stress. A Material olume is a tagged region that moves with the fluid. Hence

More information

Large Steps in Cloth Simulation. Safeer C Sushil Kumar Meena Guide: Prof. Parag Chaudhuri

Large Steps in Cloth Simulation. Safeer C Sushil Kumar Meena Guide: Prof. Parag Chaudhuri Large Steps in Cloth Simulation Safeer C Sushil Kumar Meena Guide: Prof. Parag Chaudhuri Introduction Cloth modeling a challenging problem. Phenomena to be considered Stretch, shear, bend of cloth Interaction

More information

Burgers equation - a first look at fluid mechanics and non-linear partial differential equations

Burgers equation - a first look at fluid mechanics and non-linear partial differential equations Burgers equation - a first look at fluid mechanics and non-linear partial differential equations In this assignment you will solve Burgers equation, which is useo model for example gas dynamics anraffic

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

Conservation of Mass Conservation of Energy Scaling Analysis. ESS227 Prof. Jin-Yi Yu

Conservation of Mass Conservation of Energy Scaling Analysis. ESS227 Prof. Jin-Yi Yu Lecture 2: Basic Conservation Laws Conservation of Momentum Conservation of Mass Conservation of Energy Scaling Analysis Conservation Law of Momentum Newton s 2 nd Law of Momentum = absolute velocity viewed

More information

Investigation of an implicit solver for the simulation of bubble oscillations using Basilisk

Investigation of an implicit solver for the simulation of bubble oscillations using Basilisk Investigation of an implicit solver for the simulation of bubble oscillations using Basilisk D. Fuster, and S. Popinet Sorbonne Universités, UPMC Univ Paris 6, CNRS, UMR 79 Institut Jean Le Rond d Alembert,

More information

ESCI 485 Air/Sea Interaction Lesson 1 Stresses and Fluxes Dr. DeCaria

ESCI 485 Air/Sea Interaction Lesson 1 Stresses and Fluxes Dr. DeCaria ESCI 485 Air/Sea Interaction Lesson 1 Stresses and Fluxes Dr DeCaria References: An Introduction to Dynamic Meteorology, Holton MOMENTUM EQUATIONS The momentum equations governing the ocean or atmosphere

More information

X i t react. ~min i max i. R ij smallest. X j. Physical processes by characteristic timescale. largest. t diff ~ L2 D. t sound. ~ L a. t flow.

X i t react. ~min i max i. R ij smallest. X j. Physical processes by characteristic timescale. largest. t diff ~ L2 D. t sound. ~ L a. t flow. Physical processes by characteristic timescale Diffusive timescale t diff ~ L2 D largest Sound crossing timescale t sound ~ L a Flow timescale t flow ~ L u Free fall timescale Cooling timescale Reaction

More information

OCR Physics Specification A - H156/H556

OCR Physics Specification A - H156/H556 OCR Physics Specification A - H156/H556 Module 3: Forces and Motion You should be able to demonstrate and show your understanding of: 3.1 Motion Displacement, instantaneous speed, average speed, velocity

More information

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II Elliptic Problems / Multigrid Summary of Hyperbolic PDEs We looked at a simple linear and a nonlinear scalar hyperbolic PDE There is a speed associated with the change of the solution Explicit methods

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

Vortex stretching in incompressible and compressible fluids

Vortex stretching in incompressible and compressible fluids Vortex stretching in incompressible and compressible fluids Esteban G. Tabak, Fluid Dynamics II, Spring 00 1 Introduction The primitive form of the incompressible Euler equations is given by ( ) du P =

More information

of Friction in Fluids Dept. of Earth & Clim. Sci., SFSU

of Friction in Fluids Dept. of Earth & Clim. Sci., SFSU Summary. Shear is the gradient of velocity in a direction normal to the velocity. In the presence of shear, collisions among molecules in random motion tend to transfer momentum down-shear (from faster

More information

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Problem Jörg-M. Sautter Mathematisches Institut, Universität Düsseldorf, Germany, sautter@am.uni-duesseldorf.de

More information

1/3/2011. This course discusses the physical laws that govern atmosphere/ocean motions.

1/3/2011. This course discusses the physical laws that govern atmosphere/ocean motions. Lecture 1: Introduction and Review Dynamics and Kinematics Kinematics: The term kinematics means motion. Kinematics is the study of motion without regard for the cause. Dynamics: On the other hand, dynamics

More information

Time scales. Notes. Mixed Implicit/Explicit. Newmark Methods [ ] [ ] "!t = O 1 %

Time scales. Notes. Mixed Implicit/Explicit. Newmark Methods [ ] [ ] !t = O 1 % Notes Time scales! For using Pixie (the renderer) make sure you type use pixie first! Assignment 1 questions?! [work out]! For position dependence, characteristic time interval is "!t = O 1 % $ ' # K &!

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

5.1 Fluid momentum equation Hydrostatics Archimedes theorem The vorticity equation... 42

5.1 Fluid momentum equation Hydrostatics Archimedes theorem The vorticity equation... 42 Chapter 5 Euler s equation Contents 5.1 Fluid momentum equation........................ 39 5. Hydrostatics................................ 40 5.3 Archimedes theorem........................... 41 5.4 The

More information

Partial Differential Equations II

Partial Differential Equations II Partial Differential Equations II CS 205A: Mathematical Methods for Robotics, Vision, and Graphics Justin Solomon CS 205A: Mathematical Methods Partial Differential Equations II 1 / 28 Almost Done! Homework

More information

Open boundary conditions in numerical simulations of unsteady incompressible flow

Open boundary conditions in numerical simulations of unsteady incompressible flow Open boundary conditions in numerical simulations of unsteady incompressible flow M. P. Kirkpatrick S. W. Armfield Abstract In numerical simulations of unsteady incompressible flow, mass conservation can

More information

(Refer Slide Time: 2:14)

(Refer Slide Time: 2:14) Fluid Dynamics And Turbo Machines. Professor Dr Shamit Bakshi. Department Of Mechanical Engineering. Indian Institute Of Technology Madras. Part A. Module-1. Lecture-3. Introduction To Fluid Flow. (Refer

More information

Block-Structured Adaptive Mesh Refinement

Block-Structured Adaptive Mesh Refinement Block-Structured Adaptive Mesh Refinement Lecture 2 Incompressible Navier-Stokes Equations Fractional Step Scheme 1-D AMR for classical PDE s hyperbolic elliptic parabolic Accuracy considerations Bell

More information

1. Introduction, tensors, kinematics

1. Introduction, tensors, kinematics 1. Introduction, tensors, kinematics Content: Introduction to fluids, Cartesian tensors, vector algebra using tensor notation, operators in tensor form, Eulerian and Lagrangian description of scalar and

More information

Thursday Simulation & Unity

Thursday Simulation & Unity Rigid Bodies Simulation Homework Build a particle system based either on F=ma or procedural simulation Examples: Smoke, Fire, Water, Wind, Leaves, Cloth, Magnets, Flocks, Fish, Insects, Crowds, etc. Simulate

More information

AA210A Fundamentals of Compressible Flow. Chapter 1 - Introduction to fluid flow

AA210A Fundamentals of Compressible Flow. Chapter 1 - Introduction to fluid flow AA210A Fundamentals of Compressible Flow Chapter 1 - Introduction to fluid flow 1 1.2 Conservation of mass Mass flux in the x-direction [ ρu ] = M L 3 L T = M L 2 T Momentum per unit volume Mass per unit

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

Partial Differential Equations. Examples of PDEs

Partial Differential Equations. Examples of PDEs Partial Differential Equations Almost all the elementary and numerous advanced parts of theoretical physics are formulated in terms of differential equations (DE). Newton s Laws Maxwell equations Schrodinger

More information

CHAPTER 4. Basics of Fluid Dynamics

CHAPTER 4. Basics of Fluid Dynamics CHAPTER 4 Basics of Fluid Dynamics What is a fluid? A fluid is a substance that can flow, has no fixed shape, and offers little resistance to an external stress In a fluid the constituent particles (atoms,

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

Flow and Transport. c(s, t)s ds,

Flow and Transport. c(s, t)s ds, Flow and Transport 1. The Transport Equation We shall describe the transport of a dissolved chemical by water that is traveling with uniform velocity ν through a long thin tube G with uniform cross section

More information

Lecture 7: Rheology and milli microfluidic

Lecture 7: Rheology and milli microfluidic 1 and milli microfluidic Introduction In this chapter, we come back to the notion of viscosity, introduced in its simplest form in the chapter 2. We saw that the deformation of a Newtonian fluid under

More information

AMME2261: Fluid Mechanics 1 Course Notes

AMME2261: Fluid Mechanics 1 Course Notes Module 1 Introduction and Fluid Properties Introduction Matter can be one of two states: solid or fluid. A fluid is a substance that deforms continuously under the application of a shear stress, no matter

More information

PHYS 432 Physics of Fluids: Instabilities

PHYS 432 Physics of Fluids: Instabilities PHYS 432 Physics of Fluids: Instabilities 1. Internal gravity waves Background state being perturbed: A stratified fluid in hydrostatic balance. It can be constant density like the ocean or compressible

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

Development and analysis of a Lagrange-Remap sharp interface solver for stable and accurate atomization computations

Development and analysis of a Lagrange-Remap sharp interface solver for stable and accurate atomization computations ICLASS 2012, 12 th Triennial International Conference on Liquid Atomization and Spray Systems, Heidelberg, Germany, September 2-6, 2012 Development and analysis of a Lagrange-Remap sharp interface solver

More information

Hamiltonian aspects of fluid dynamics

Hamiltonian aspects of fluid dynamics Hamiltonian aspects of fluid dynamics CDS 140b Joris Vankerschaver jv@caltech.edu CDS 01/29/08, 01/31/08 Joris Vankerschaver (CDS) Hamiltonian aspects of fluid dynamics 01/29/08, 01/31/08 1 / 34 Outline

More information

UNIVERSITY of LIMERICK

UNIVERSITY of LIMERICK UNIVERSITY of LIMERICK OLLSCOIL LUIMNIGH Faculty of Science and Engineering END OF SEMESTER ASSESSMENT PAPER MODULE CODE: MA4607 SEMESTER: Autumn 2012-13 MODULE TITLE: Introduction to Fluids DURATION OF

More information

g (z) = 1 (1 + z/a) = 1

g (z) = 1 (1 + z/a) = 1 1.4.2 Gravitational Force g is the gravitational force. It always points towards the center of mass, and it is proportional to the inverse square of the distance above the center of mass: g (z) = GM (a

More information

1. Introduction, fluid properties (1.1, 2.8, 4.1, and handouts)

1. Introduction, fluid properties (1.1, 2.8, 4.1, and handouts) 1. Introduction, fluid properties (1.1, 2.8, 4.1, and handouts) Introduction, general information Course overview Fluids as a continuum Density Compressibility Viscosity Exercises: A1 Fluid mechanics Fluid

More information