Physics-Based Animation

Size: px
Start display at page:

Download "Physics-Based Animation"

Transcription

1 CSCI 5980/8980: Special Topics in Computer Science Physics-Based Animation 13 Fluid simulation with grids October 20, 2015

2 Today Presentation schedule Fluid simulation with grids Course feedback survey (again)

3 (Tentative) presentation schedule Oct Nov Dec Tue Thu 20 Fluids on grids Liquid surfaces Elasticity Finite element method 29 3 Sound (Bryan) Cloth and hair 5 10 Cloth (Alex & Morgan) Fluids (Ran & Jingying) Fire (Devin & Lei) TBD Solids (George & Jie) Thanksgiving 26 1 Real-time stuff (Zahra) Real-time stuff (Dan & Matt) 3 8 Wrap-up day Project presentations Project presentations

4 Course feedback survey

5 Representing continua

6 Particles (SPH) Values on moving particles Approximate continuous field by weighted averaging A(x) = X A i m i i W (x x i,h) Derivatives by differentiating weighting kernel

7 Grids Values on nodes of rectilinear grid Easy to interpolate using only 4 (in 2D) or 8 (in 3D) nearest values

8 Grids class Grid { int m, n, o; Vec3d origin; double dx; Type *values; Type get(int i, int j, int k);... };

9 Grids 11 c 21 c 11 x c 02 c 12 c 22 c 01 c 11 c 21 c 00 c c 11 c 01 x c 21 c 01 2 x ½ 0 ½

10 Grids (finite differences) c 02 c 12 c 22 c 01 c 11 c 21 r 2 c 1 h c 00 c 10 c 20

11 Meshes (FEM) Values on nodes of (not necessarily regular) mesh Evaluate derivatives on elements (triangles/ tetrahedra/etc.)

12 Fluids on grids

13 Grids vs. particles Particles Mass, velocity, pressure, etc. stored on particles Particles move with fluid Grids Velocity, pressure, etc. stored on grid cells Grid doesn t move

14 Advection Grid doesn t move, fluid flows through grid Lagrangian Dc =0 6=0 Eulerian

15 Advection Dc + u rc Lagrangian derivative Change due to movement of fluid ( advection ) Eulerian derivative Proof: differentiate c(x(t), t) with respect to t

16 The fluid equations Du Dt = f ext rp + µr 2 u Du Dt = f ext 1 rp + + u ru = f ext 1 rp + r2 u

17 + u ru = f ext 1 rp + r2 u Lots of different terms, hard to integrate safely in one step Deal with one term at a time, ignoring all the others (e.g. IMEX)

18 u n Operator + u ru =0 for time Δt = 1 f ext for time Δt External forces = µ r2 u for time Δt = 1 rp for time Δt u n+1

19 Advection

20 Advection Goal: Integrate c/ t + u c = 0 for time Δt Interpretation: c moves with speed u for time Δt Solution: To get the value of c n+1 at any point, figure out where it came from and take the value of c n from there

21 Advection Trace backwards through u and look up values c n u n c n+1 Semi-Lagrangian advection

22 Advection Input: initial grid c n, velocity field u n Output: final grid c n+1 For each grid cell x i Backtrace position, e.g. x back = x i u i Δt Set output c i n+1 = interpolate c n at x back To advect velocities, just use u n as the initial grid too.

23

24 Pressure

25 Pressure In SPH, density ρ was used for two things: 1. Normalizing for uneven particle distribution 2. Computing pressure forces With grids, we don t need to track ρ. But what about pressure? Treat it as a constraint force: ρ = const dρ/dt = 0

26 Incompressibility Flow Fixed surface n u Net flow ZZinto/out of region = u ˆn da ZZZ = r u dv [Divergence theorem] We want net flow to be 0 for all possible regions, so u = 0 everywhere

27 Pressure u new = u t rp r u new =0 Constraint: u new should be divergence-free, find the constraint response p that makes it so (analogous to computing λ so that Jv = 0) r 2 p = t r u Ignore the /Δt (just a rescaling)

28 Staggered grids Store pressure at cell centers, but velocity at cell faces (r u) i,j u i+1,j u i,j x Finite differences line up u and p at cell centers Components of p and u at cell faces + v i,j+1 v i,j x p p i,j+1 p v u i,j v i,j+1 u i+1,j p i 1,j p i,j p i+1,j v u u v i,j u u v v p p i,j 1 p

29 Boundary conditions Solid obstacles: u n = 0 Fluid cannot flow into or out of obstacles Free surface: p = 0 p = 0 Air applies negligible force on water

30 Pressure solve 2 p = u Build a big linear system Ap = b and solve it Rows of A contain stencil for 2 (except at boundaries, be careful!) b contains values of u Then update u u p

31 The other bits External forces e.g. f = β(t T 0 )g Gravity, buoyancy, user interaction, Explicit integration is fine Viscosity Often ignored because numerical damping is enough For really thick fluids, use implicit integration

32 u n Operator + u ru =0 for time Δt = 1 f ext for time Δt External forces = µ r2 u for time Δt = 1 rp for time Δt u n+1

33 Further reading Bridson and Müller-Fischer, Fluid Simulation for Computer Animation (SIGGRAPH 2007 course notes) Bridson, Fluid Simulation for Computer Graphics (2008 book)

34 Course feedback survey

35 Next class Even more fluids Hybrid (particles + grid) techniques for advection Liquid surface reconstruction

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

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

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

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

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

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

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

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

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

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

SOE3213/4: CFD Lecture 1

SOE3213/4: CFD Lecture 1 What is CFD SOE3213/4: CFD Lecture 1 3d 3d Computational Fluid Dynamics { use of computers to study uid dynamics. Solve the Navier-Stokes Equations (NSE) : r:u = 0 Du Dt = rp + r 2 u + F 4 s for 4 unknowns,

More information

Semi-Lagrangian Formulations for Linear Advection Equations and Applications to Kinetic Equations

Semi-Lagrangian Formulations for Linear Advection Equations and Applications to Kinetic Equations Semi-Lagrangian Formulations for Linear Advection and Applications to Kinetic Department of Mathematical and Computer Science Colorado School of Mines joint work w/ Chi-Wang Shu Supported by NSF and AFOSR.

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

Smoothed Particle Hydrodynamics (SPH) Huamin Wang

Smoothed Particle Hydrodynamics (SPH) Huamin Wang Smoothed Particle Hydrodynamics (SPH) Huamin Wang Fluid Representation Fluid is represented using a set of particles. Particle i has position x i, velocity v i, and mass m i. Animation Example Using 10

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

5. FVM discretization and Solution Procedure

5. FVM discretization and Solution Procedure 5. FVM discretization and Solution Procedure 1. The fluid domain is divided into a finite number of control volumes (cells of a computational grid). 2. Integral form of the conservation equations are discretized

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

What make cloth hard to simulate?

What make cloth hard to simulate? Cloth Simulation What make cloth hard to simulate? Due to the thin and flexible nature of cloth, it produces detailed folds and wrinkles, which in turn can lead to complicated selfcollisions. Cloth is

More information

Earth System Modeling Domain decomposition

Earth System Modeling Domain decomposition Earth System Modeling Domain decomposition Graziano Giuliani International Centre for Theorethical Physics Earth System Physics Section Advanced School on Regional Climate Modeling over South America February

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

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

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

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

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

Ideas from Vector Calculus Kurt Bryan

Ideas from Vector Calculus Kurt Bryan Ideas from Vector Calculus Kurt Bryan Most of the facts I state below are for functions of two or three variables, but with noted exceptions all are true for functions of n variables..1 Tangent Line Approximation

More information

Procedural Animation. D.A. Forsyth

Procedural Animation. D.A. Forsyth Procedural Animation D.A. Forsyth Big points Two important types of procedural animation slice and dice data, like texture synthesis build (approximate) physical simulation Extremely powerful issues how

More information

Lecture 41: Highlights

Lecture 41: Highlights Lecture 41: Highlights The goal of this lecture is to remind you of some of the key points that we ve covered this semester Note that this is not the complete set of topics that may appear on the final

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

Numerical Simulations. Duncan Christie

Numerical Simulations. Duncan Christie Numerical Simulations Duncan Christie Motivation There isn t enough time to derive the necessary methods to do numerical simulations, but there is enough time to survey what methods and codes are available

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

A Hybrid Method for the Wave Equation. beilina

A Hybrid Method for the Wave Equation.   beilina A Hybrid Method for the Wave Equation http://www.math.unibas.ch/ beilina 1 The mathematical model The model problem is the wave equation 2 u t 2 = (a 2 u) + f, x Ω R 3, t > 0, (1) u(x, 0) = 0, x Ω, (2)

More information

Effect of Initial Geometry on Surface Flatness after Arc Welding Analyzed with MPS Method

Effect of Initial Geometry on Surface Flatness after Arc Welding Analyzed with MPS Method Journal of Mechanics Engineering and Automation 5 (2015) 63-67 doi: 10.17265/2159-5275/2015.02.001 D DAVID PUBLISHING Effect of Initial Geometry on Surface Flatness after Arc Welding Analyzed with MPS

More information

The Advanced Research WRF (ARW) Dynamics Solver

The Advanced Research WRF (ARW) Dynamics Solver Dynamics: Introduction The Advanced Research WRF (ARW) Dynamics Solver 1. What is a dynamics solver? 2. Variables and coordinates 3. Equations 4. Time integration scheme 5. Grid staggering 6. Advection

More information

The Generalized Interpolation Material Point Method

The Generalized Interpolation Material Point Method Compaction of a foam microstructure The Generalized Interpolation Material Point Method Tungsten Particle Impacting sandstone The Material Point Method (MPM) 1. Lagrangian material points carry all state

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

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

Numerical Solution Techniques in Mechanical and Aerospace Engineering

Numerical Solution Techniques in Mechanical and Aerospace Engineering Numerical Solution Techniques in Mechanical and Aerospace Engineering Chunlei Liang LECTURE 9 Finite Volume method II 9.1. Outline of Lecture Conservation property of Finite Volume method Apply FVM to

More information

Assignment 13 Assigned Mon Oct 4

Assignment 13 Assigned Mon Oct 4 Assignment 3 Assigned Mon Oct 4 We refer to the integral table in the back of the book. Section 7.5, Problem 3. I don t see this one in the table in the back of the book! But it s a very easy substitution

More information

Eulerian models. 2.1 Basic equations

Eulerian models. 2.1 Basic equations 2 Eulerian models In this chapter we give a short overview of the Eulerian techniques for modelling turbulent flows, transport and chemical reactions. We first present the basic Eulerian equations describing

More information

The Relationship between Discrete Calculus Methods and other Mimetic Approaches

The Relationship between Discrete Calculus Methods and other Mimetic Approaches The Relationship between Discrete Calculus Methods and other Mimetic Approaches Blair Perot Theoretical and Computational Fluid Dynamics Laboratory Woudschoten Conerence Oct. 2011 October 7, 2011 Background

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

x j r i V i,j+1/2 r Ci,j Ui+1/2,j U i-1/2,j Vi,j-1/2

x j r i V i,j+1/2 r Ci,j Ui+1/2,j U i-1/2,j Vi,j-1/2 Merging of drops to form bamboo waves Yuriko Y. Renardy and Jie Li Department of Mathematics and ICAM Virginia Polytechnic Institute and State University Blacksburg, VA -, U.S.A. May, Abstract Topological

More information

Physics 218 Lecture 12

Physics 218 Lecture 12 Physics 218 Lecture 12 Dr. David Toback Physics 218, Lecture XII 1 This week This week we will finish up Chapters 6 & 7 Last set of topics for Exam 2 Exam 2: Thurs, October 26 th Covers chapters 1-7 Physics

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

The behaviour of high Reynolds flows in a driven cavity

The behaviour of high Reynolds flows in a driven cavity The behaviour of high Reynolds flows in a driven cavity Charles-Henri BRUNEAU and Mazen SAAD Mathématiques Appliquées de Bordeaux, Université Bordeaux 1 CNRS UMR 5466, INRIA team MC 351 cours de la Libération,

More information

Control Systems I. Lecture 4: Diagonalization, Modal Analysis, Intro to Feedback. Readings: Emilio Frazzoli

Control Systems I. Lecture 4: Diagonalization, Modal Analysis, Intro to Feedback. Readings: Emilio Frazzoli Control Systems I Lecture 4: Diagonalization, Modal Analysis, Intro to Feedback Readings: Emilio Frazzoli Institute for Dynamic Systems and Control D-MAVT ETH Zürich October 13, 2017 E. Frazzoli (ETH)

More information

softened probabilistic

softened probabilistic Justin Solomon MIT Understand geometry from a softened probabilistic standpoint. Somewhere over here. Exactly here. One of these two places. Query 1 2 Which is closer, 1 or 2? Query 1 2 Which is closer,

More information

Electromagnetism Physics 15b

Electromagnetism Physics 15b Electromagnetism Physics 15b Lecture #5 Curl Conductors Purcell 2.13 3.3 What We Did Last Time Defined divergence: Defined the Laplacian: From Gauss s Law: Laplace s equation: F da divf = lim S V 0 V Guass

More information

MECH 5810 Module 3: Conservation of Linear Momentum

MECH 5810 Module 3: Conservation of Linear Momentum MECH 5810 Module 3: Conservation of Linear Momentum D.J. Willis Department of Mechanical Engineering University of Massachusetts, Lowell MECH 5810 Advanced Fluid Dynamics Fall 2017 Outline 1 Announcements

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

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

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

Divergence Formulation of Source Term

Divergence Formulation of Source Term Preprint accepted for publication in Journal of Computational Physics, 2012 http://dx.doi.org/10.1016/j.jcp.2012.05.032 Divergence Formulation of Source Term Hiroaki Nishikawa National Institute of Aerospace,

More information

Constitutive models. Constitutive model: determines P in terms of deformation

Constitutive models. Constitutive model: determines P in terms of deformation Constitutive models Constitutive model: determines P in terms of deformation Elastic material: P depends only on current F Hyperelastic material: work is independent of path strain energy density function

More information

High Order Semi-Lagrangian WENO scheme for Vlasov Equations

High Order Semi-Lagrangian WENO scheme for Vlasov Equations High Order WENO scheme for Equations Department of Mathematical and Computer Science Colorado School of Mines joint work w/ Andrew Christlieb Supported by AFOSR. Computational Mathematics Seminar, UC Boulder

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

Prof. Simon Tett, Chair of Earth System Dynamics & Modelling: The University of Edinburgh

Prof. Simon Tett, Chair of Earth System Dynamics & Modelling: The University of Edinburgh SAGES Scottish Alliance for Geoscience, Environment & Society Modelling Climate Change Prof. Simon Tett, Chair of Earth System Dynamics & Modelling: The University of Edinburgh Climate Modelling Climate

More information

DEFORMATION AND FRACTURE ANALYSIS OF ELASTIC SOLIDS BASED ON A PARTICLE METHOD

DEFORMATION AND FRACTURE ANALYSIS OF ELASTIC SOLIDS BASED ON A PARTICLE METHOD Blucher Mechanical Engineering Proceedings May 2014, vol. 1, num. 1 www.proceedings.blucher.com.br/evento/10wccm DEFORMATION AND FRACTURE ANALYSIS OF ELASTIC SOLIDS BASED ON A PARTICLE METHOD R. A. Amaro

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

Tentative Physics 1 Standards

Tentative Physics 1 Standards Tentative Physics 1 Standards Mathematics MC1. Arithmetic: I can add, subtract, multiply, and divide real numbers, take their natural and common logarithms, and raise them to real powers and take real

More information

A symmetric positive definite formulation for monolithic fluid structure interaction

A symmetric positive definite formulation for monolithic fluid structure interaction A symmetric positive definite formulation for monolithic fluid structure interaction Avi Robinson-Mosher, Craig Schroeder, Ronald Fedkiw Stanford University, 353 Serra Mall Room 207, Stanford, CA 94305

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

Cosmic Structure Formation on Supercomputers (and laptops)

Cosmic Structure Formation on Supercomputers (and laptops) Cosmic Structure Formation on Supercomputers (and laptops) Lecture 4: Smoothed particle hydrodynamics and baryonic sub-grid models Benjamin Moster! Ewald Puchwein 1 Outline of the lecture course Lecture

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

Pressure-velocity correction method Finite Volume solution of Navier-Stokes equations Exercise: Finish solving the Navier Stokes equations

Pressure-velocity correction method Finite Volume solution of Navier-Stokes equations Exercise: Finish solving the Navier Stokes equations Today's Lecture 2D grid colocated arrangement staggered arrangement Exercise: Make a Fortran program which solves a system of linear equations using an iterative method SIMPLE algorithm Pressure-velocity

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

MATH 280 Multivariate Calculus Fall Integrating a vector field over a surface

MATH 280 Multivariate Calculus Fall Integrating a vector field over a surface MATH 280 Multivariate Calculus Fall 2011 Definition Integrating a vector field over a surface We are given a vector field F in space and an oriented surface in the domain of F as shown in the figure below

More information

(Refer Slide Time: 03: 09)

(Refer Slide Time: 03: 09) Computational Electromagnetics and Applications Professor Krish Sankaran Indian Institute of Technology Bombay Lecture No 26 Finite Volume Time Domain Method-I Welcome back in the precious lectures we

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

SPH for the Modeling of non-newtonian Fluids with Thermal-Dependent Rheology

SPH for the Modeling of non-newtonian Fluids with Thermal-Dependent Rheology SPH for the Modeling of non-newtonian Fluids with Thermal-Dependent Rheology G. Bilotta 1,2 1 Dipartimento di Matematica e Informatica, Università di Catania, Italy 2 Istituto Nazionale Geofisica e Vulcanologia,

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

Level Set and Phase Field Methods: Application to Moving Interfaces and Two-Phase Fluid Flows

Level Set and Phase Field Methods: Application to Moving Interfaces and Two-Phase Fluid Flows Level Set and Phase Field Methods: Application to Moving Interfaces and Two-Phase Fluid Flows Abstract Maged Ismail Claremont Graduate University Level Set and Phase Field methods are well-known interface-capturing

More information

FVM for Fluid-Structure Interaction with Large Structural Displacements

FVM for Fluid-Structure Interaction with Large Structural Displacements FVM for Fluid-Structure Interaction with Large Structural Displacements Željko Tuković and Hrvoje Jasak Zeljko.Tukovic@fsb.hr, h.jasak@wikki.co.uk Faculty of Mechanical Engineering and Naval Architecture

More information

Semi-implicit methods, nonlinear balance, and regularized equations

Semi-implicit methods, nonlinear balance, and regularized equations ATMOSPHERIC SCIENCE LETTERS Atmos. Sci. Let. 8: 1 6 (7 Published online 9 January 7 in Wiley InterScience (www.interscience.wiley.com.1 Semi-implicit methods, nonlinear balance, and regularized equations

More information

Chapter 6: The Definite Integral

Chapter 6: The Definite Integral Name: Date: Period: AP Calc AB Mr. Mellina Chapter 6: The Definite Integral v v Sections: v 6.1 Estimating with Finite Sums v 6.5 Trapezoidal Rule v 6.2 Definite Integrals 6.3 Definite Integrals and Antiderivatives

More information

Split explicit methods

Split explicit methods Split explicit methods Almut Gassmann Meteorological Institute of the University of Bonn Germany St.Petersburg Summer School 2006 on nonhydrostatic dynamics and fine scale data assimilation Two common

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

.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

ES 111 Mathematical Methods in the Earth Sciences Lecture Outline 15 - Tues 20th Nov 2018 First and Higher Order Differential Equations

ES 111 Mathematical Methods in the Earth Sciences Lecture Outline 15 - Tues 20th Nov 2018 First and Higher Order Differential Equations ES 111 Mathematical Methods in the Earth Sciences Lecture Outline 15 - Tues 20th Nov 2018 First and Higher Order Differential Equations Integrating Factor Here is a powerful technique which will work (only!)

More information

4.1 LAWS OF MECHANICS - Review

4.1 LAWS OF MECHANICS - Review 4.1 LAWS OF MECHANICS - Review Ch4 9 SYSTEM System: Moving Fluid Definitions: System is defined as an arbitrary quantity of mass of fixed identity. Surrounding is everything external to this system. Boundary

More information

Announcements. CSE332: Data Abstractions Lecture 2: Math Review; Algorithm Analysis. Today. Mathematical induction. Dan Grossman Spring 2010

Announcements. CSE332: Data Abstractions Lecture 2: Math Review; Algorithm Analysis. Today. Mathematical induction. Dan Grossman Spring 2010 Announcements CSE332: Data Abstractions Lecture 2: Math Review; Algorithm Analysis Dan Grossman Spring 2010 Project 1 posted Section materials on using Eclipse will be very useful if you have never used

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

Formulation and performance of the Variable-Cubic Atmospheric Model

Formulation and performance of the Variable-Cubic Atmospheric Model Formulation and performance of the Variable-Cubic Atmospheric Model John McGregor CSIRO Marine and Atmospheric Research Aspendale, Melbourne Southern Hemisphere PDEs on the Sphere NCAR 11 April 2014 CSIRO

More information

ρ x + fv f 'w + F x ρ y fu + F y Fundamental Equation in z coordinate p = ρrt or pα = RT Du uv tanφ Dv Dt + u2 tanφ + vw a a = 1 p Dw Dt u2 + v 2

ρ x + fv f 'w + F x ρ y fu + F y Fundamental Equation in z coordinate p = ρrt or pα = RT Du uv tanφ Dv Dt + u2 tanφ + vw a a = 1 p Dw Dt u2 + v 2 Fundamental Equation in z coordinate p = ρrt or pα = RT Du uv tanφ + uw Dt a a = 1 p ρ x + fv f 'w + F x Dv Dt + u2 tanφ + vw a a = 1 p ρ y fu + F y Dw Dt u2 + v 2 = 1 p a ρ z g + f 'u + F z Dρ Dt + ρ

More information

Volume in n Dimensions

Volume in n Dimensions Volume in n Dimensions MA 305 Kurt Bryan Introduction You ve seen that if we have two vectors v and w in two dimensions then the area spanned by these vectors can be computed as v w = v 1 w 2 v 2 w 1 (where

More information

Traffic Flow I. Kurt Bryan

Traffic Flow I. Kurt Bryan Introduction Traffic Flow I Kurt Bryan Consider a stretch of freeway with no entrance or eit ramps. On such a stretch of freeway we clearly have conservation of cars, barring any wrecks. Thus in our conservation

More information

The Distribution Function

The Distribution Function The Distribution Function As we have seen before the distribution function (or phase-space density) f( x, v, t) d 3 x d 3 v gives a full description of the state of any collisionless system. Here f( x,

More information

Smoothed Particle Hydrodynamics (SPH) 4. May 2012

Smoothed Particle Hydrodynamics (SPH) 4. May 2012 Smoothed Particle Hydrodynamics (SPH) 4. May 2012 Calculating density SPH density estimator Weighted summation over nearby particles: ρ(r) = N neigh b=1 m bw (r r b, h) W weight function with dimension

More information

Scientific Computing I

Scientific Computing I Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Neckel Winter 2013/2014 Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 1 Part I: Introduction to

More information

Continuous Gradient Method to Cell Crossing Instability

Continuous Gradient Method to Cell Crossing Instability Continuous Gradient Method to Cell Crossing Instability D. Z. Zhang X. Ma P. T. Giguere Fluid Dynamics and Solid Mechanics Group, T-3, Theoretical Division Los Alamos National Laboratory Los Alamos, New

More information

pifreeze A Freeze / Thaw Plug-in for FEFLOW User Guide

pifreeze A Freeze / Thaw Plug-in for FEFLOW User Guide pifreeze A Freeze / Thaw Plug-in for FEFLOW User Guide MIKE 2016 DHI headquarters Agern Allé 5 DK-2970 Hørsholm Denmark +45 4516 9200 Telephone +45 4516 9333 Support +45 4516 9292 Telefax mike@dhigroup.com

More information

1. INTRODUCTION TO CFD SPRING 2019

1. INTRODUCTION TO CFD SPRING 2019 1. INTRODUCTION TO CFD SPRING 2019 1.1 What is computational fluid dynamics? 1.2 Basic principles of CFD 1.3 Stages in a CFD simulation 1.4 Fluid-flow equations 1.5 The main discretisation methods Appendices

More information

Chapter 2 The Continuum Equations

Chapter 2 The Continuum Equations Chapter 2 The Continuum Equations 2.1 The conservation of mass In solid mechanics and thermodynamics we keep track of a well defined fluid mass and this mass is usually trivially specified, as in the case

More information

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V Part I: Introduction to Finite Element Methods Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Necel Winter 4/5 The Model Problem FEM Main Ingredients Wea Forms and Wea

More information

MITOCW watch?v=6hewlsfqlty

MITOCW watch?v=6hewlsfqlty MITOCW watch?v=6hewlsfqlty The following content is provided under a Creative Commons license. Your support will help MIT OpenCourseWare continue to offer high quality educational resources for free. To

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

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

Mathematical Concepts & Notation

Mathematical Concepts & Notation Mathematical Concepts & Notation Appendix A: Notation x, δx: a small change in x t : the partial derivative with respect to t holding the other variables fixed d : the time derivative of a quantity that

More information