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

Size: px
Start display at page:

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

Transcription

1 Fluid dynamics

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

3 Fields Domain Ω R2 Scalar field f :Ω R Vector field f : Ω R2

4 Types of derivatives Derivatives measure how something changes due to its parameters Temporal derivatives Spatial derivatives gradient operator divergence operator Laplacian operator f t f = [ f x, f y ] T f = f x x + f y y 2 f = ( f) = 2 f x + 2 f y

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

6 Representation Density ρ :Ω [0, 1] Domain Ω Velocity u :Ω R 3

7 Coffee cup equation Navier-Stokes Momentum equation u t = (u )u 1 ρ p + s 2 u + f Incompressibility condition u =0 u: velocity p: pressure s: kinematic viscosity f: body force ρ: fluid density

8 Momentum equation Each particle represents a little blob of fluid with mass m, a volume V, and a velocity u The acceleration of the particle a Du Dt The Newton s law m Du Dt = F

9 Forces acting on fluids Gravity: mg Pressure: - p Imbalance of higher pressure Viscosity: µ u Force that makes particle moves at average speed dynamic viscosity coefficient: µ

10 Momentum equation The movement of a blob of fluid m Du Dt Divide by volume ρ Du Dt = mg V p + Vµ u = ρg p + µ u Rearrange equation giving Navier-Stoke Du Dt + 1 p = g + s u ρ

11 Lagrangian v.s. Eulerian Lagrangian point of view describes motion as points travel around space over time Eulerian point of view describes motion as the change of velocity field in a stationary domain Lagrangian approach is conceptually easier, but Eulerian approach makes the spatial gradient easier to compute/approximate

12 Material derivative Dq Dt = q t + u q x + v q y + w q z d q(t, x) = q dt t = q t + q u = Dq Dt + q dx dt

13 Advection Advection describe how quantity, q, moves with the velocity field u Density Velocity Dρ Dt = ρ t + u ρ Du Dt = u t + u u

14 Advection momentum equation Du Dt + 1 p = g + s u ρ Advection Projection Diffusion Body force u t = (u )u 1 ρ p + s 2 u + f u =0

15 Density advection ρ t = (u )ρ

16 Velocity advection u t = (u )u 1 ρ p + s 2 u + f s.t. u =0

17 Projection Advection Projection Diffusion Body force u t = (u )u 1 ρ p + s 2 u + f u =0

18 Divergence free u > 0? u < 0?

19 Divergence free u = 0

20 Projection u t = (u )u 1 ρ p + s 2 u + f s.t. u =0

21 Diffusion Advection Projection Diffusion Body force u t = (u )u 1 ρ p + s 2 u + f u =0

22 High viscosity fluids

23 Dropping viscosity Viscosity plays a minor role in most fluids Numeric methods introduce errors which can be physically reinterpreted as viscosity Fluid with no viscosity is called inviscid

24 Body force Advection Projection Diffusion Body force u t = (u )u 1 ρ p + s 2 u + f u =0

25 External forces Gravity Heat Surface tension User-specified forces (stirring coffee)

26 Boundary conditions Solid walls The fluid cannot go in and out of it Control the normal velocity Free surfaces Air can be represented as a region where the pressure is zero Do not control the velocity at the surface

27 Solid boundary Velocity at the boundary u ˆn = u solid ˆn No-slip condition: u = u solid Pressure at the boundary Make the fluid incompressible AND enforce the solid boundary condition

28 Physics recap Physical quantity represented as fields Navier-Stokes PDE describes the dynamics

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

30 Challenges What is the representation for fluids? represent velocity and pressure What is the equation of motion for fluids? approximate Navier-Stokes in a discrete domain compute Navier-Stokes efficiently

31 Grid structure p i,j+1 v i,j+1/2 p i 1,j u i 1/2,j p i,j u i+1/2,j p i+1,j v i,j 1/2 p i,j 1

32 Explicit integration Solving for the differential equation explicitly, namely u t = (u )u 1 ρ p + s 2 u + f u t+1 = u t + h u(t) You get this...

33 Explicit integration

34 Stable fluids Invented by Jos Stam Simple, fast, and unconditionally stable

35 Splitting methods Suppose we had a system x t = f(x) =g(x)+h(x) We define simulation function S f S f (x, t) :x(t) x(t)+ tf(x) Then we could define S f (x, t) :x(t + t) =S g (x, t) S h (x, t)

36 Splitting methods u t = (u )u 1 ρ p + s 2 u + f w 0 = u(x, t) add force Advect Diffuse Project w 0 (x) w 1 (x) w 2 (x) w 3 (x) w 4 (x) u(x, t+δt) = w 4

37 Splitting methods u t = (u )u 1 ρ p + s 2 u + f w 0 = u(x, t) add force Advect Diffuse Project w 0 (x) w 1 (x) w 2 (x) w 3 (x) w 4 (x) u(x, t+δt) = w 4

38 Body forces

39 Splitting methods u t = (u )u 1 ρ p + s 2 u + f w 0 = u(x, t) add force Advect Diffuse Project w 0 (x) w 1 (x) w 2 (x) w 3 (x) w 4 (x) u(x, t+δt) = w 4

40 Advection

41

42 Numerical dissipation Semi-Lagrangian advection tend to smooth out sharp features by averaging the velocity field The numerical errors result in a different advection equation solved by semi-largrangian q t + u q x = u x 2 q x 2 Smooth out small vortices in inviscid fluids

43 Splitting methods u t = (u )u 1 ρ p + s 2 u + f w 0 = u(x, t) add force Advect Diffuse Project w 0 (x) w 1 (x) w 2 (x) w 3 (x) w 4 (x) u(x, t+δt) = w 4

44 Diffusion Solve for the effect of viscosity w 2 t = ν 2 w 2 Use an implicit method for stable result (I ν t 2 )w 3 (x) =w 2 (x)

45 Splitting methods u t = (u )u 1 ρ p + s 2 u + f w 0 = u(x, t) add force Advect Diffuse Project w 0 (x) w 1 (x) w 2 (x) w 3 (x) w 4 (x) u(x, t+δt) = w 4

46 Projection P( )

47 Projection Projection step subtracts off the pressure from the intermediate velocity field w 3 w 4 = w 3 t 1 ρ p project(δt, u) must satisfies two conditions: divergence free: u t+1 =0 boundary velocity: u t+1 ˆn = u solid ˆn

48 Boundary conditions Dirichlet boundary condition for free surfaces Neumann boundary condition for solid walls u t+1 i+1/2,j = u i+1/2,j t 1 ρ since p i+1,j p i,j x u t+1 i+1/2,j = u solid p i,j u i+1/2,j p i+1,j p i+1,j = p i,j + ρ x t (u i+1/2,j u solid )

49 Divergence-free condition p i,j+1 u t+1 i+1/2,j ut+1 i 1/2,j x + vt+1 i,j+1/2 vt+1 i,j 1/2 x =0 replace u t+1 i+1/2,j (and other terms) v i,j+1/2 p i 1,j p i,j p i+1,j u i 1/2,j u i+1/2,j with u i+1/2,j t 1 ρ p i+1,j p i,j x v i,j 1/2 p i,j 1 result in a discrete Poisson equation t ρ ( ) ( 4pi,j p i+1,j p i,j+1 p i 1,j p i,j 1 ui+1/2,j u i 1/2,j x 2 = x + v i,j+1/2 v i,j 1/2 x )

50 The pressure equations If grid cell (i, j + 1) is in air and (i+1, j) is a solid p i,j+1 v i,j+1/2 replace p i,j+1 with zero p i 1,j u i 1/2,j p i,j u i+1/2,j p i+1,j t ρ replace p i+1,j with the value from Neumann condition p i,j + ρ x t (u i+1/2,j u solid ) 0 ( ) ( 4pi,j p i+1,j p i,j+1 p i 1,j p i,j 1 ui+1/2,j u i 1/2,j x 2 = x v i,j 1/2 p i,j 1 + v i,j+1/2 v i,j 1/2 x )

51 Solve a linear system Ap = b Construct matrix A: diagonal entry: # of non-solid neighbors off-diagonal: 0 if the neighbor is non-fluid cell and -1 if the neighbor is fluid cell A is symmetric positive definite Use preconditioned conjugate gradient

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

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

Fluid Animation. Christopher Batty November 17, 2011

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

More information

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

( ) 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

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

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

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

Mathematical Theory of Non-Newtonian Fluid

Mathematical Theory of Non-Newtonian Fluid Mathematical Theory of Non-Newtonian Fluid 1. Derivation of the Incompressible Fluid Dynamics 2. Existence of Non-Newtonian Flow and its Dynamics 3. Existence in the Domain with Boundary Hyeong Ohk Bae

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

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

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

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

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

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

The Orchestra of Partial Differential Equations. Adam Larios

The Orchestra of Partial Differential Equations. Adam Larios The Orchestra of Partial Differential Equations Adam Larios 19 January 2017 Landscape Seminar Outline 1 Fourier Series 2 Some Easy Differential Equations 3 Some Not-So-Easy Differential Equations Outline

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

Fundamentals Physics

Fundamentals Physics Fundamentals Physics And Differential Equations 1 Dynamics Dynamics of a material point Ideal case, but often sufficient Dynamics of a solid Including rotation, torques 2 Position, Velocity, Acceleration

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

Improvement of Calculation Stability for Slow Fluid Flow Analysis Using Particle Method *

Improvement of Calculation Stability for Slow Fluid Flow Analysis Using Particle Method * Materials Transactions, Vol. 58, No. 3 (2017) pp. 479 to 484 2017 Japan Foundry Engineering Society Improvement of Calculation Stability for Slow Fluid Flow Analysis Using Particle Method * Naoya Hirata

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

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

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

Advection, Conservation, Conserved Physical Quantities, Wave Equations

Advection, Conservation, Conserved Physical Quantities, Wave Equations EP711 Supplementary Material Thursday, September 4, 2014 Advection, Conservation, Conserved Physical Quantities, Wave Equations Jonathan B. Snively!Embry-Riddle Aeronautical University Contents EP711 Supplementary

More information

d v 2 v = d v d t i n where "in" and "rot" denote the inertial (absolute) and rotating frames. Equation of motion F =

d v 2 v = d v d t i n where in and rot denote the inertial (absolute) and rotating frames. Equation of motion F = Governing equations of fluid dynamics under the influence of Earth rotation (Navier-Stokes Equations in rotating frame) Recap: From kinematic consideration, d v i n d t i n = d v rot d t r o t 2 v rot

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

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

Chapter 3. Finite Difference Methods for Hyperbolic Equations Introduction Linear convection 1-D wave equation

Chapter 3. Finite Difference Methods for Hyperbolic Equations Introduction Linear convection 1-D wave equation Chapter 3. Finite Difference Methods for Hyperbolic Equations 3.1. Introduction Most hyperbolic problems involve the transport of fluid properties. In the equations of motion, the term describing the transport

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

Fluid Dynamics Exercises and questions for the course

Fluid Dynamics Exercises and questions for the course Fluid Dynamics Exercises and questions for the course January 15, 2014 A two dimensional flow field characterised by the following velocity components in polar coordinates is called a free vortex: u r

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

Navier-Stokes equations

Navier-Stokes equations 1 Navier-Stokes equations Introduction to spectral methods for the CSC Lunchbytes Seminar Series. Incompressible, hydrodynamic turbulence is described completely by the Navier-Stokes equations where t

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

Daniel J. Jacob, Models of Atmospheric Transport and Chemistry, 2007.

Daniel J. Jacob, Models of Atmospheric Transport and Chemistry, 2007. 1 0. CHEMICAL TRACER MODELS: AN INTRODUCTION Concentrations of chemicals in the atmosphere are affected by four general types of processes: transport, chemistry, emissions, and deposition. 3-D numerical

More information

Modeling using conservation laws. Let u(x, t) = density (heat, momentum, probability,...) so that. u dx = amount in region R Ω. R

Modeling using conservation laws. Let u(x, t) = density (heat, momentum, probability,...) so that. u dx = amount in region R Ω. R Modeling using conservation laws Let u(x, t) = density (heat, momentum, probability,...) so that u dx = amount in region R Ω. R Modeling using conservation laws Let u(x, t) = density (heat, momentum, probability,...)

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

2. Conservation of Mass

2. Conservation of Mass 2 Conservation of Mass The equation of mass conservation expresses a budget for the addition and removal of mass from a defined region of fluid Consider a fixed, non-deforming volume of fluid, V, called

More information

FEniCS Course. Lecture 6: Incompressible Navier Stokes. Contributors Anders Logg André Massing

FEniCS Course. Lecture 6: Incompressible Navier Stokes. Contributors Anders Logg André Massing FEniCS Course Lecture 6: Incompressible Navier Stokes Contributors Anders Logg André Massing 1 / 11 The incompressible Navier Stokes equations u + u u ν u + p = f in Ω (0, T ] u = 0 in Ω (0, T ] u = g

More information

First, Second, and Third Order Finite-Volume Schemes for Diffusion

First, Second, and Third Order Finite-Volume Schemes for Diffusion First, Second, and Third Order Finite-Volume Schemes for Diffusion Hiro Nishikawa 51st AIAA Aerospace Sciences Meeting, January 10, 2013 Supported by ARO (PM: Dr. Frederick Ferguson), NASA, Software Cradle.

More information

Math 575-Lecture Viscous Newtonian fluid and the Navier-Stokes equations

Math 575-Lecture Viscous Newtonian fluid and the Navier-Stokes equations Math 575-Lecture 13 In 1845, tokes extended Newton s original idea to find a constitutive law which relates the Cauchy stress tensor to the velocity gradient, and then derived a system of equations. The

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

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

The Hopf equation. The Hopf equation A toy model of fluid mechanics

The Hopf equation. The Hopf equation A toy model of fluid mechanics The Hopf equation A toy model of fluid mechanics 1. Main physical features Mathematical description of a continuous medium At the microscopic level, a fluid is a collection of interacting particles (Van

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

Fundamentals of Fluid Dynamics: Elementary Viscous Flow

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

More information

Finite Volume Method

Finite Volume Method Finite Volume Method An Introduction Praveen. C CTFD Division National Aerospace Laboratories Bangalore 560 037 email: praveen@cfdlab.net April 7, 2006 Praveen. C (CTFD, NAL) FVM CMMACS 1 / 65 Outline

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

Fundamentals of Fluid Dynamics: Ideal Flow Theory & Basic Aerodynamics

Fundamentals of Fluid Dynamics: Ideal Flow Theory & Basic Aerodynamics Fundamentals of Fluid Dynamics: Ideal Flow Theory & Basic Aerodynamics Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI (after: D.J. ACHESON s Elementary Fluid Dynamics ) bluebox.ippt.pan.pl/

More information

NDT&E Methods: UT. VJ Technologies CAVITY INSPECTION. Nondestructive Testing & Evaluation TPU Lecture Course 2015/16.

NDT&E Methods: UT. VJ Technologies CAVITY INSPECTION. Nondestructive Testing & Evaluation TPU Lecture Course 2015/16. CAVITY INSPECTION NDT&E Methods: UT VJ Technologies NDT&E Methods: UT 6. NDT&E: Introduction to Methods 6.1. Ultrasonic Testing: Basics of Elasto-Dynamics 6.2. Principles of Measurement 6.3. The Pulse-Echo

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

The Embedded Boundary Integral Method (EBI) for the Incompressible Navier-Stokes equations

The Embedded Boundary Integral Method (EBI) for the Incompressible Navier-Stokes equations The Embedded Boundary Integral Method (EBI) for the Incompressible Navier-Stokes equations George Biros Lexing Ying and Denis Zorin Courant Institute of Mathematical Sciences, New York University, NY 10012,

More information

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers Applied and Computational Mathematics 2017; 6(4): 202-207 http://www.sciencepublishinggroup.com/j/acm doi: 10.11648/j.acm.20170604.18 ISSN: 2328-5605 (Print); ISSN: 2328-5613 (Online) A Robust Preconditioned

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

INTRODUCTION TO PDEs

INTRODUCTION TO PDEs INTRODUCTION TO PDEs In this course we are interested in the numerical approximation of PDEs using finite difference methods (FDM). We will use some simple prototype boundary value problems (BVP) and initial

More information

Lagrangian acceleration in confined 2d turbulent flow

Lagrangian acceleration in confined 2d turbulent flow Lagrangian acceleration in confined 2d turbulent flow Kai Schneider 1 1 Benjamin Kadoch, Wouter Bos & Marie Farge 3 1 CMI, Université Aix-Marseille, France 2 LMFA, Ecole Centrale, Lyon, France 3 LMD, Ecole

More information

Week 6 Notes, Math 865, Tanveer

Week 6 Notes, Math 865, Tanveer Week 6 Notes, Math 865, Tanveer. Energy Methods for Euler and Navier-Stokes Equation We will consider this week basic energy estimates. These are estimates on the L 2 spatial norms of the solution u(x,

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

6.2 Governing Equations for Natural Convection

6.2 Governing Equations for Natural Convection 6. Governing Equations for Natural Convection 6..1 Generalized Governing Equations The governing equations for natural convection are special cases of the generalized governing equations that were discussed

More information

Candidates must show on each answer book the type of calculator used. Log Tables, Statistical Tables and Graph Paper are available on request.

Candidates must show on each answer book the type of calculator used. Log Tables, Statistical Tables and Graph Paper are available on request. UNIVERSITY OF EAST ANGLIA School of Mathematics Spring Semester Examination 2004 FLUID DYNAMICS Time allowed: 3 hours Attempt Question 1 and FOUR other questions. Candidates must show on each answer book

More information

Lecture 3: 1. Lecture 3.

Lecture 3: 1. Lecture 3. Lecture 3: 1 Lecture 3. Lecture 3: 2 Plan for today Summary of the key points of the last lecture. Review of vector and tensor products : the dot product (or inner product ) and the cross product (or vector

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

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

1 Introduction to Governing Equations 2 1a Methodology... 2

1 Introduction to Governing Equations 2 1a Methodology... 2 Contents 1 Introduction to Governing Equations 2 1a Methodology............................ 2 2 Equation of State 2 2a Mean and Turbulent Parts...................... 3 2b Reynolds Averaging.........................

More information

Basic concepts in viscous flow

Basic concepts in viscous flow Élisabeth Guazzelli and Jeffrey F. Morris with illustrations by Sylvie Pic Adapted from Chapter 1 of Cambridge Texts in Applied Mathematics 1 The fluid dynamic equations Navier-Stokes equations Dimensionless

More information

Chapter 2. General concepts. 2.1 The Navier-Stokes equations

Chapter 2. General concepts. 2.1 The Navier-Stokes equations Chapter 2 General concepts 2.1 The Navier-Stokes equations The Navier-Stokes equations model the fluid mechanics. This set of differential equations describes the motion of a fluid. In the present work

More information

Lecture 3: The Navier-Stokes Equations: Topological aspects

Lecture 3: The Navier-Stokes Equations: Topological aspects Lecture 3: The Navier-Stokes Equations: Topological aspects September 9, 2015 1 Goal Topology is the branch of math wich studies shape-changing objects; objects which can transform one into another without

More information

Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5

Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5 Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5 Jingwei Zhu May 14, 2014 Instructor: Surya Pratap Vanka 1 Project Description The objective of

More information

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

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

More information

Quick Recapitulation of Fluid Mechanics

Quick Recapitulation of Fluid Mechanics Quick Recapitulation of Fluid Mechanics Amey Joshi 07-Feb-018 1 Equations of ideal fluids onsider a volume element of a fluid of density ρ. If there are no sources or sinks in, the mass in it will change

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

Stochastic Simulation of Complex Fluid Flows

Stochastic Simulation of Complex Fluid Flows Stochastic Simulation of Complex Fluid Flows Aleksandar Donev Courant Institute, New York University & Alejandro L. Garcia, SJSU John B. Bell, LBNL Florencio Balboa Usabiaga, UAM Rafael Delgado-Buscalioni,

More information

Additive Manufacturing Module 8

Additive Manufacturing Module 8 Additive Manufacturing Module 8 Spring 2015 Wenchao Zhou zhouw@uark.edu (479) 575-7250 The Department of Mechanical Engineering University of Arkansas, Fayetteville 1 Evaluating design https://www.youtube.com/watch?v=p

More information

Lagrangian Dynamics & Mixing

Lagrangian Dynamics & Mixing V Lagrangian Dynamics & Mixing See T&L, Ch. 7 The study of the Lagrangian dynamics of turbulence is, at once, very old and very new. Some of the earliest work on fluid turbulence in the 1920 s, 30 s and

More information

Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang,

Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang, Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang, yfwang09@stanford.edu 1. Problem setting In this project, we present a benchmark simulation for segmented flows, which contain

More information

PDEs, part 1: Introduction and elliptic PDEs

PDEs, part 1: Introduction and elliptic PDEs PDEs, part 1: Introduction and elliptic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2013 Partial di erential equations The solution depends on several variables,

More information

Implementation of 3D Incompressible N-S Equations. Mikhail Sekachev

Implementation of 3D Incompressible N-S Equations. Mikhail Sekachev Implementation of 3D Incompressible N-S Equations Mikhail Sekachev Navier-Stokes Equations The motion of a viscous incompressible fluid is governed by the Navier-Stokes equations u + t u = ( u ) 0 Quick

More information

Partitioned Methods for Multifield Problems

Partitioned Methods for Multifield Problems C Partitioned Methods for Multifield Problems Joachim Rang, 6.7.2016 6.7.2016 Joachim Rang Partitioned Methods for Multifield Problems Seite 1 C One-dimensional piston problem fixed wall Fluid flexible

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

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

Topics in Fluid Dynamics: Classical physics and recent mathematics

Topics in Fluid Dynamics: Classical physics and recent mathematics Topics in Fluid Dynamics: Classical physics and recent mathematics Toan T. Nguyen 1,2 Penn State University Graduate Student Seminar @ PSU Jan 18th, 2018 1 Homepage: http://math.psu.edu/nguyen 2 Math blog:

More information

Runge-Kutta-Chebyshev Projection Method

Runge-Kutta-Chebyshev Projection Method Runge-Kutta-Chebyshev Projection Method Zheming Zheng Linda Petzold Department of Mechanical Engineering, University of California Santa Barbara, Santa Barbara, CA 93106, USA June 8, 2006 This work was

More information

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 1 / 43 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS Treatment of Boundary Conditions These slides are partially based on the recommended textbook: Culbert

More information

ASTR 320: Solutions to Problem Set 2

ASTR 320: Solutions to Problem Set 2 ASTR 320: Solutions to Problem Set 2 Problem 1: Streamlines A streamline is defined as a curve that is instantaneously tangent to the velocity vector of a flow. Streamlines show the direction a massless

More information

A PRACTICALLY UNCONDITIONALLY GRADIENT STABLE SCHEME FOR THE N-COMPONENT CAHN HILLIARD SYSTEM

A PRACTICALLY UNCONDITIONALLY GRADIENT STABLE SCHEME FOR THE N-COMPONENT CAHN HILLIARD SYSTEM A PRACTICALLY UNCONDITIONALLY GRADIENT STABLE SCHEME FOR THE N-COMPONENT CAHN HILLIARD SYSTEM Hyun Geun LEE 1, Jeong-Whan CHOI 1 and Junseok KIM 1 1) Department of Mathematics, Korea University, Seoul

More information

3. FORMS OF GOVERNING EQUATIONS IN CFD

3. FORMS OF GOVERNING EQUATIONS IN CFD 3. FORMS OF GOVERNING EQUATIONS IN CFD 3.1. Governing and model equations in CFD Fluid flows are governed by the Navier-Stokes equations (N-S), which simpler, inviscid, form is the Euler equations. For

More information

In this section, mathematical description of the motion of fluid elements moving in a flow field is

In this section, mathematical description of the motion of fluid elements moving in a flow field is Jun. 05, 015 Chapter 6. Differential Analysis of Fluid Flow 6.1 Fluid Element Kinematics In this section, mathematical description of the motion of fluid elements moving in a flow field is given. A small

More information

7 EQUATIONS OF MOTION FOR AN INVISCID FLUID

7 EQUATIONS OF MOTION FOR AN INVISCID FLUID 7 EQUATIONS OF MOTION FOR AN INISCID FLUID iscosity is a measure of the thickness of a fluid, and its resistance to shearing motions. Honey is difficult to stir because of its high viscosity, whereas water

More information

Diffusion Equation and Mean Free Path

Diffusion Equation and Mean Free Path Diffusion Equation and Mean Free Path Speaker: Xiaolei Chen Advisor: Prof. Xiaolin Li Department of Applied Mathematics and Statistics Stony Brook University (SUNY) Content General Introduction Analytic

More information

Marching on the BL equations

Marching on the BL equations Marching on the BL equations Harvey S. H. Lam February 10, 2004 Abstract The assumption is that you are competent in Matlab or Mathematica. White s 4-7 starting on page 275 shows us that all generic boundary

More information

Vorticity and Dynamics

Vorticity and Dynamics Vorticity and Dynamics In Navier-Stokes equation Nonlinear term ω u the Lamb vector is related to the nonlinear term u 2 (u ) u = + ω u 2 Sort of Coriolis force in a rotation frame Viscous term ν u = ν

More information

A semi-implicit non-hydrostatic covariant dynamical kernel using spectral representation in the horizontal and a height based vertical coordinate

A semi-implicit non-hydrostatic covariant dynamical kernel using spectral representation in the horizontal and a height based vertical coordinate A semi-implicit non-hydrostatic covariant dynamical kernel using spectral representation in the horizontal and a height based vertical coordinate Juan Simarro and Mariano Hortal AEMET Agencia Estatal de

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

Stability of Shear Flow

Stability of Shear Flow Stability of Shear Flow notes by Zhan Wang and Sam Potter Revised by FW WHOI GFD Lecture 3 June, 011 A look at energy stability, valid for all amplitudes, and linear stability for shear flows. 1 Nonlinear

More information

J. Liou Tulsa Research Center Amoco Production Company Tulsa, OK 74102, USA. Received 23 August 1990 Revised manuscript received 24 October 1990

J. Liou Tulsa Research Center Amoco Production Company Tulsa, OK 74102, USA. Received 23 August 1990 Revised manuscript received 24 October 1990 Computer Methods in Applied Mechanics and Engineering, 94 (1992) 339 351 1 A NEW STRATEGY FOR FINITE ELEMENT COMPUTATIONS INVOLVING MOVING BOUNDARIES AND INTERFACES THE DEFORMING-SPATIAL-DOMAIN/SPACE-TIME

More information

1 Introduction. J.-L. GUERMOND and L. QUARTAPELLE 1 On incremental projection methods

1 Introduction. J.-L. GUERMOND and L. QUARTAPELLE 1 On incremental projection methods J.-L. GUERMOND and L. QUARTAPELLE 1 On incremental projection methods 1 Introduction Achieving high order time-accuracy in the approximation of the incompressible Navier Stokes equations by means of fractional-step

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

Experience with DNS of particulate flow using a variant of the immersed boundary method

Experience with DNS of particulate flow using a variant of the immersed boundary method Experience with DNS of particulate flow using a variant of the immersed boundary method Markus Uhlmann Numerical Simulation and Modeling Unit CIEMAT Madrid, Spain ECCOMAS CFD 2006 Motivation wide range

More information