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

Size: px
Start display at page:

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

Transcription

1 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 flow, and investigate the appearance of shock waves. We will however start with the simpler linear advection equation and proceed stepwise to Burgers equation. Background The Navier-Stokes equations describe the motion of fluid substances. They are non-linear partial differential equations that can be useo model a range of systems from water flowing in pipes to hot dense astrophysical plasma. Unfortunately, the nonlinearity makes most problems difficult or impossible to solve and leads to phenomena such as turbulence. The Navier-Stokes equations is the subject of contemporary research. Burgers equation is a one-dimensional Navier-Stokes equation valid for simplified conditions. Consider a mass element of a continuous substance. We assume now that the dynamics is only taking place in one dimension. Following Newton we have then for the mass element, dm, with cross section area A, moving in the x -direction with velocity u(x, t): F x = dm a x F x = dm du x dt F x = ρ du x Adx. (1) dt The velocity can change with time in two ways. First, the velocity varies in time at a certain point in space, and in addition the mass element changes its position with time anhereby, if the velocity is space-dependent, the velocity changes: F x = ρ du x dt Adx ( F x = ρ ) x + ρ x Adx ( F x = ρ ) x + ρu x x Adx (2) To apply Newton s equation we neeo know the total force that works on the mass element. We can in principle have three different type of forces. First there might be an external force (like the gravitational force). Second a pressure gradient over the mass element gives a net force, and last there are intermolecular forces within the medium that can be approximated with the help of the concept of viscosity. We first assume that all these forces are zero and obtain the result (skipping the index x on the velocity u(x, t)) + u(x, t) = 0, (3) which is the inviscid (i.e. without viscosity) Burgers equation. This equation is non-linear and it is the simplest equation for which the solutions can develop shock waves. Alternatively the equation can be written: This is an equation of the general form + 1 ( u(x, t) 2 ) = 0. (4) 2 + f(u) = 0. (5)

2 With viscosity Burgers equation is + u(x, t) = ν 2 u(x, t) 2, (6) where the ν is the kinematic viscosity. The kinematic viscosity is the (more common) dynamic viscosity divided by the density. The dynamic viscosity has dimension ML 1 T 1 (Nsm 2 in SI-units), while the kinematic viscosity has dimension L 2 T 1. The linear advection equation: Before we start with Burgers equation itself we look at the simpler linear advection equation: + v(x, t) = 0, (7) where the v(x, t) is a known function, we will even put it to a constant, v(x, t) = v 0. We can get some further insight into the solution to this equation with the method of characteristics. We look for a characteristic curve along which the equation is an ordinary differential equation. Instead of Eq.(7) we search an equation of the form First d u (x (s), t (s)) ds d u (x (s), t (s)) ds and by comparison with Eq.(7) we conclude that which leads to: d x d s = η (u, x (s), t (s)). (8) = d x d s + d s, (9) = v(x, t) and d s = 1 (10) d u ds = + v(x, t) = 0. (11) With constant v(x, t) = v 0, and with appropriate boundary conditions we get further = 1, an(s = 0) = 0 t d s = s d x d s = v 0 and x(s = 0) = x 0 x(s) = x 0 + v 0 s x(t) = x 0 + v 0 t d u d s = 0, and u(0) = f(x(t = 0)) u(x(t), t) = f(x(t = 0)) = f(x(t) v 0t). (12) We have thus founhat along the lines in the (x, t)-plane, defined by x(t) x 0 = v 0 t, the values of u remains constant. Imagine now an initial velocity distribution. When t increases it will move in space with velocity v 0, and it will keep its form. For example an initial velocity as a function of x (a Gaussian centered around x = 0): u(x, t = 0) = e x2 (13) will at later time t be i.e. a Gaussian centered around x = v 0 t u(x, t) = e (x v 0t) 2, (14)

3 Task Use a grid in x and a grid in t. Create a initial velocity profile in the form a Gaussian u(x, t = 0) = 1 2πσ 2 e (x x 0) 2 /(2σ 2 ) (15) 1) Solve the linear advection equation, Eq.(7), (with v(x, t) = v 0 ) to get u at later times with the following methods The FTCS (Forward Time Centered Space) method (Numerical Recipes Eq ). This method does not work, but it is really interesting to see how bad it is! The Lax Method (Numerical Recipes chapter ). Note the small difference compareo FTCS. The Upwind Method ((Numerical Recipes Eq ). The Lax-Wendroff scheme (Numerical Recipes chapter and below) 2) Solve the Burgers equation Eq.(4) with the Upwind method anhe Lax-Wendroff scheme (see below). Look at the velocity profile for rather small t to see the onset of shock waves. If you want to see shock waves in real life you can look at this article (includes a video). The methods for the linear advection equation Forward Time Centered Space (FTCS). With a two point formula for the derivatives we can write which is the forward form of the derivative, and which is the centered form. From Eq. (7) we then get: u(x j, t n+1 = u(x j, t n ) 1 2 This method can be shown to diverge regardless of the time-step. The Lax method; a slight change of the FTCS method where leads to u(x j, t n+1 ) u(x j, t n ), (16) t u(x j+1, t n ) u(x j 1, t n ), (17) 2 t (u(x j+1, t n ) u(x j 1, t n )). (18) u(x j, t n ) 1 2 (u(x j+1, t n ) + u(x j 1, t n )) (19) u(x j, t n+1 ) = 1 2 (u(x j+1, t n ) + u(x j 1, t n )) 1 2 (u(x j+1, t n ) u(x j 1, t n )), (20) which works much better. Why? Adding u(x j, t n ) on both sides of the equation we find: u(x j, t n+1 ) u(x j, t n ) = 1 2 (u(x j+1, t n ) 2u(x j, t n ) + u(x j 1, t n )) 1 2 Eq. (20) is thus identical to Eq. (18) up to the term (u(x j+1, t n ) u(x j 1, t n )). (21) 1 2 (u(x j+1, t n ) 2u(x j, t n ) + u(x j 1, t n )) 2 2 u(x j, t n ) 2 2. (22) This last term has the form of a viscosity term (cf. Eq. (6)). Viscosity models dissipation (loss of mechanical energy) and acts like a damping term. What happen with the velocity profile now? Try

4 and check! The Lax method give stable results for v < / t. The Upwind Method; Along the characteristic curves u stays constant. If (x x, t n ) lies on the same characteristic curve as (x j, t n + 1) u(x j, t n+1 ) = u(x x, t n ). (23) Now x x x j (which is exact if v is a constant, but otherwise it is the first approximation), and we can Taylor expand u(x x, t n ) around x j 1. u(x x, t n ) = u(x j 1 + (x x x j 1 ), t n ) u(x x, t n ) = u(x j 1, t n ) + (x j x j 1 ) (x j 1, t n ) +... u(x x, t n ) u(x j 1, t n ) + ( ) u(x j, t n ) u(x j 1, t n ) u(x j, t n+1 ) u(x j, t n ) v(x j, t n ) t (u(x j, t n ) u(x j 1, t n )). (24) This is the upwind method for v(x j, t n ) > 0. In the case when / t = v the method is in fact exact. For v(x j, t n ) < 0 we get in the same way, (see also Numerical Recipes) u(x j, t n+1 ) u(x j, t n ) v(x j, t n ) t (u(x j+1, t n ) u(x j, t n )). (25) The idea here was to get the values x x through linear interpolation between the known points. We can get higher numerical accuracy if we use three points instead of two. This is the Lax Wendroff scheme. The Lax Wendroff scheme: It is most easily understood if we note that knowing the solutions u(x j 1, t n ), u(x j, t n ), u(x j+1, t n ), we can construct a second order polynomial, p(x, t n ), which goes through these three points. p(x, t n ) = (x x j )(x x j+1 ) (x j 1 x j )(x j 1 x j+1 ) u(x j 1, t n ) + (x x j 1)(x x j+1 ) (x j x j 1 )(x j x j+1 ) u(x j, t n ) + (x x j 1 )(x x j ) (x j+1 x j 1 )(x j+1 x j ) u(x j+1, t n ). (26) We have further from the characteristic lines that if (x x, t n ) lies on the same line as (x j, t n + 1), and with v = constant: x x x j 1 = (1 v t ) x x x j = v t x x x j+1 = (1 + v t ). (27) Combining Eq.(26) and Eq.(27) we get: u(x j, t n+1 ) = u(x x, t n ) u(x j, t n+1 ) p(x x, t n ) u(x j, t n+1 ) (1 + v t 1 2 v t v t (1 + )u(x j 1, t n ) )(1 v t )u(x j, t n ) v t v t (1 )u(x j+1, t n ). (28)

5 Rearranging the terms we see that this equals u(x j, t n+1 ) u(x j, t n ) 1 v t 2 (u(x j+1, t n ) u(x j 1, t n )) + 1 ( ) v t 2 (u(x j+1, t n ) 2u(x j, t n ) + u(x j 1, t n )), (29) 2 The same expression would be obtained by centered finite difference formula for the space derivatives in the equation u(x j, t n+1 ) u(x j, t n ) v t (x j, t n ) + (v t) 2 2 u(x j, t n ) 2 (30) and again we finhus that the numerical method gives us a viscosity type term. The methods for the Burgers equation The upwind scheme scheme for Burgers equation: For an equation of the type + f(u) (as Burgers equation) we can generalize the upwind method; = 0. (31) u(x j, t n+1 ) u(x j, t n ) t {f(u(x j, t n )) f(u(x j 1, t n ))}, for f(u(x j+1/2, t n )) > 0 u(x j, t n+1 ) u(x j, t n ) t {f(u(x j+1, t n )) f(u(x j, t n ))}, for f(u(x j 1/2, t n )) < 0. (32) Note that with f = v 0 u we recover Eq To get the Lax Wendroff scheme for Burgers equation we can proceed as follows, (see also Numerical Recipes , but note then that there is a misprint in ; there is a factor 1/2 missing in the seconerm on the right-hand side). Use first the Lax scheme to take half a step in t, first for x j+1/2 anhen for x j 1/2 u(x j+1/2, t n+1/2 ) = 1 2 (u(x j+1, t n ) + u(x j, t n )) 1 t 2 (f(x j+1, t n ) f(x j, t n )) (33) u(x j 1/2, t n+1/2 ) = 1 2 (u(x j, t n ) + u(x j 1, t n )) 1 t 2 (f(x j, t n ) f(x j 1, t n )) (34) we use Eq.(33-34) to calculate f(x j+1/2, t n+1/2 ) and f(x j 1/2, t n+1/2 ) anhen calculate u(x j, t n+1 ) = u(x j, t n ) t (f(x j+1/2, t n+1/2 ) f(x j 1/2, t n+1/2 )) (35) with f = vu(x, t) expression (29) is re-obtained. For Burgers equation we should use f = u 2 (x, t)/2.

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

The one-dimensional equations for the fluid dynamics of a gas can be written in conservation form as follows:

The one-dimensional equations for the fluid dynamics of a gas can be written in conservation form as follows: Topic 7 Fluid Dynamics Lecture The Riemann Problem and Shock Tube Problem A simple one dimensional model of a gas was introduced by G.A. Sod, J. Computational Physics 7, 1 (1978), to test various algorithms

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

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

Chapter 3 Burgers Equation

Chapter 3 Burgers Equation Chapter 3 Burgers Equation One of the major challenges in the field of comple systems is a thorough understanding of the phenomenon of turbulence. Direct numerical simulations (DNS) have substantially

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

Lecture Notes on Numerical Schemes for Flow and Transport Problems

Lecture Notes on Numerical Schemes for Flow and Transport Problems Lecture Notes on Numerical Schemes for Flow and Transport Problems by Sri Redeki Pudaprasetya sr pudap@math.itb.ac.id Department of Mathematics Faculty of Mathematics and Natural Sciences Bandung Institute

More information

Lecture Notes on Numerical Schemes for Flow and Transport Problems

Lecture Notes on Numerical Schemes for Flow and Transport Problems Lecture Notes on Numerical Schemes for Flow and Transport Problems by Sri Redeki Pudaprasetya sr pudap@math.itb.ac.id Department of Mathematics Faculty of Mathematics and Natural Sciences Bandung Institute

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

Info. No lecture on Thursday in a week (March 17) PSet back tonight

Info. No lecture on Thursday in a week (March 17) PSet back tonight Lecture 0 8.086 Info No lecture on Thursday in a week (March 7) PSet back tonight Nonlinear transport & conservation laws What if transport becomes nonlinear? Remember: Nonlinear transport A first attempt

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

Last time: Diffusion - Numerical scheme (FD) Heat equation is dissipative, so why not try Forward Euler:

Last time: Diffusion - Numerical scheme (FD) Heat equation is dissipative, so why not try Forward Euler: Lecture 7 18.086 Last time: Diffusion - Numerical scheme (FD) Heat equation is dissipative, so why not try Forward Euler: U j,n+1 t U j,n = U j+1,n 2U j,n + U j 1,n x 2 Expected accuracy: O(Δt) in time,

More information

AE/ME 339. Computational Fluid Dynamics (CFD) K. M. Isaac. Momentum equation. Computational Fluid Dynamics (AE/ME 339) MAEEM Dept.

AE/ME 339. Computational Fluid Dynamics (CFD) K. M. Isaac. Momentum equation. Computational Fluid Dynamics (AE/ME 339) MAEEM Dept. AE/ME 339 Computational Fluid Dynamics (CFD) 9//005 Topic7_NS_ F0 1 Momentum equation 9//005 Topic7_NS_ F0 1 Consider the moving fluid element model shown in Figure.b Basis is Newton s nd Law which says

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

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

VISCOUS FLUX LIMITERS

VISCOUS FLUX LIMITERS VISCOUS FLUX LIMITERS E. F. Toro Department of Aerospace Science College of Aeronautics Cranfield Institute of Technology Cranfield, Beds MK43 OAL England. Abstract We present Numerical Viscosity Functions,

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

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

1 Introduction to PDE MATH 22C. 1. Introduction To Partial Differential Equations Recall: A function f is an input-output machine for numbers:

1 Introduction to PDE MATH 22C. 1. Introduction To Partial Differential Equations Recall: A function f is an input-output machine for numbers: 1 Introduction to PDE MATH 22C 1. Introduction To Partial Differential Equations Recall: A function f is an input-output machine for numbers: y = f(t) Output y 2R Input t 2R Name of function f t=independent

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

ENO and WENO schemes. Further topics and time Integration

ENO and WENO schemes. Further topics and time Integration ENO and WENO schemes. Further topics and time Integration Tefa Kaisara CASA Seminar 29 November, 2006 Outline 1 Short review ENO/WENO 2 Further topics Subcell resolution Other building blocks 3 Time Integration

More information

Chp 4: Non-linear Conservation Laws; the Scalar Case. By Prof. Dinshaw S. Balsara

Chp 4: Non-linear Conservation Laws; the Scalar Case. By Prof. Dinshaw S. Balsara Chp 4: Non-linear Conservation Laws; the Scalar Case By Prof. Dinshaw S. Balsara 1 4.1) Introduction We have seen that monotonicity preserving reconstruction and iemann solvers are essential building blocks

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

Numerical Methods for Conservation Laws WPI, January 2006 C. Ringhofer C2 b 2

Numerical Methods for Conservation Laws WPI, January 2006 C. Ringhofer C2 b 2 Numerical Methods for Conservation Laws WPI, January 2006 C. Ringhofer ringhofer@asu.edu, C2 b 2 2 h2 x u http://math.la.asu.edu/ chris Last update: Jan 24, 2006 1 LITERATURE 1. Numerical Methods for Conservation

More information

Announcements. Topics: Homework:

Announcements. Topics: Homework: Announcements Topics: - sections 7.3 (the definite integral +area), 7.4 (FTC), 7.5 (additional techniques of integration) * Read these sections and study solved examples in your textbook! Homework: - review

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

Travelling waves. Chapter 8. 1 Introduction

Travelling waves. Chapter 8. 1 Introduction Chapter 8 Travelling waves 1 Introduction One of the cornerstones in the study of both linear and nonlinear PDEs is the wave propagation. A wave is a recognizable signal which is transferred from one part

More information

Multiscale Hydrodynamic Phenomena

Multiscale Hydrodynamic Phenomena M2, Fluid mechanics 2014/2015 Friday, December 5th, 2014 Multiscale Hydrodynamic Phenomena Part I. : 90 minutes, NO documents 1. Quick Questions In few words : 1.1 What is dominant balance? 1.2 What is

More information

2.3 The Turbulent Flat Plate Boundary Layer

2.3 The Turbulent Flat Plate Boundary Layer Canonical Turbulent Flows 19 2.3 The Turbulent Flat Plate Boundary Layer The turbulent flat plate boundary layer (BL) is a particular case of the general class of flows known as boundary layer flows. The

More information

Announcements. Topics: Homework:

Announcements. Topics: Homework: Announcements Topics: - sections 7.4 (FTC), 7.5 (additional techniques of integration), 7.6 (applications of integration) * Read these sections and study solved examples in your textbook! Homework: - review

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

Before we consider two canonical turbulent flows we need a general description of turbulence.

Before we consider two canonical turbulent flows we need a general description of turbulence. Chapter 2 Canonical Turbulent Flows Before we consider two canonical turbulent flows we need a general description of turbulence. 2.1 A Brief Introduction to Turbulence One way of looking at turbulent

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

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

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

Waves in a Shock Tube

Waves in a Shock Tube Waves in a Shock Tube Ivan Christov c February 5, 005 Abstract. This paper discusses linear-wave solutions and simple-wave solutions to the Navier Stokes equations for an inviscid and compressible fluid

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

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

The Euler Equation of Gas-Dynamics

The Euler Equation of Gas-Dynamics The Euler Equation of Gas-Dynamics A. Mignone October 24, 217 In this lecture we study some properties of the Euler equations of gasdynamics, + (u) = ( ) u + u u + p = a p + u p + γp u = where, p and u

More information

ICES REPORT A Multilevel-WENO Technique for Solving Nonlinear Conservation Laws

ICES REPORT A Multilevel-WENO Technique for Solving Nonlinear Conservation Laws ICES REPORT 7- August 7 A Multilevel-WENO Technique for Solving Nonlinear Conservation Laws by Todd Arbogast, Chieh-Sen Huang, and Xikai Zhao The Institute for Computational Engineering and Sciences The

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

P = 1 3 (σ xx + σ yy + σ zz ) = F A. It is created by the bombardment of the surface by molecules of fluid.

P = 1 3 (σ xx + σ yy + σ zz ) = F A. It is created by the bombardment of the surface by molecules of fluid. CEE 3310 Thermodynamic Properties, Aug. 27, 2010 11 1.4 Review A fluid is a substance that can not support a shear stress. Liquids differ from gasses in that liquids that do not completely fill a container

More information

Chapter 2: Fluid Dynamics Review

Chapter 2: Fluid Dynamics Review 7 Chapter 2: Fluid Dynamics Review This chapter serves as a short review of basic fluid mechanics. We derive the relevant transport equations (or conservation equations), state Newton s viscosity law leading

More information

Chapter 10 Exercises

Chapter 10 Exercises Chapter 10 Exercises From: Finite Difference Methods for Ordinary and Partial Differential Equations by R. J. LeVeque, SIAM, 2007. http://www.amath.washington.edu/ rl/fdmbook Exercise 10.1 (One-sided and

More information

Lattice Boltzmann Method

Lattice Boltzmann Method 3 Lattice Boltzmann Method 3.1 Introduction The lattice Boltzmann method is a discrete computational method based upon the lattice gas automata - a simplified, fictitious molecular model. It consists of

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

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

0.3.4 Burgers Equation and Nonlinear Wave

0.3.4 Burgers Equation and Nonlinear Wave 16 CONTENTS Solution to step (discontinuity) initial condition u(x, 0) = ul if X < 0 u r if X > 0, (80) u(x, t) = u L + (u L u R ) ( 1 1 π X 4νt e Y 2 dy ) (81) 0.3.4 Burgers Equation and Nonlinear Wave

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

arxiv: v2 [physics.flu-dyn] 31 Aug 2016

arxiv: v2 [physics.flu-dyn] 31 Aug 2016 arxiv:608.0724v2 [physics.flu-dyn] 3 Aug 206 ANALYSIS OF FLUID VELOCITY VECTOR FIELD DIVERGENCE u IN FUNCTION OF VARIABLE FLUID DENSITY ρ( x,t) const AND CONDITIONS FOR VANISHING VISCOSITY OF COMPRESSIBLE

More information

Notes: Outline. Shock formation. Notes: Notes: Shocks in traffic flow

Notes: Outline. Shock formation. Notes: Notes: Shocks in traffic flow Outline Scalar nonlinear conservation laws Traffic flow Shocks and rarefaction waves Burgers equation Rankine-Hugoniot conditions Importance of conservation form Weak solutions Reading: Chapter, 2 R.J.

More information

Numerical Methods for Modern Traffic Flow Models. Alexander Kurganov

Numerical Methods for Modern Traffic Flow Models. Alexander Kurganov Numerical Methods for Modern Traffic Flow Models Alexander Kurganov Tulane University Mathematics Department www.math.tulane.edu/ kurganov joint work with Pierre Degond, Université Paul Sabatier, Toulouse

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

Fluid Equations for Rarefied Gases

Fluid Equations for Rarefied Gases 1 Fluid Equations for Rarefied Gases Jean-Luc Thiffeault Department of Applied Physics and Applied Mathematics Columbia University http://plasma.ap.columbia.edu/~jeanluc 23 March 2001 with E. A. Spiegel

More information

Lattice Boltzmann Method for Fluid Simulations

Lattice Boltzmann Method for Fluid Simulations Lattice Boltzmann Method for Fluid Simulations Yuanxun Bill Bao & Justin Meskas April 14, 2011 1 Introduction In the last two decades, the Lattice Boltzmann method (LBM) has emerged as a promising tool

More information

2.2. Methods for Obtaining FD Expressions. There are several methods, and we will look at a few:

2.2. Methods for Obtaining FD Expressions. There are several methods, and we will look at a few: .. Methods for Obtaining FD Expressions There are several methods, and we will look at a few: ) Taylor series expansion the most common, but purely mathematical. ) Polynomial fitting or interpolation the

More information

Hierarchical Modeling of Complicated Systems

Hierarchical Modeling of Complicated Systems Hierarchical Modeling of Complicated Systems C. David Levermore Department of Mathematics and Institute for Physical Science and Technology University of Maryland, College Park, MD lvrmr@math.umd.edu presented

More information

UNIVERSITY OF EAST ANGLIA

UNIVERSITY OF EAST ANGLIA UNIVERSITY OF EAST ANGLIA School of Mathematics May/June UG Examination 2007 2008 FLUIDS DYNAMICS WITH ADVANCED TOPICS Time allowed: 3 hours Attempt question ONE and FOUR other questions. Candidates must

More information

Non-Differentiable Embedding of Lagrangian structures

Non-Differentiable Embedding of Lagrangian structures Non-Differentiable Embedding of Lagrangian structures Isabelle Greff Joint work with J. Cresson Université de Pau et des Pays de l Adour CNAM, Paris, April, 22nd 2010 Position of the problem 1. Example

More information

In this chapter, we study the calculus of vector fields.

In this chapter, we study the calculus of vector fields. 16 VECTOR CALCULUS VECTOR CALCULUS In this chapter, we study the calculus of vector fields. These are functions that assign vectors to points in space. VECTOR CALCULUS We define: Line integrals which can

More information

Turbulence Modeling I!

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

More information

Chapter 1. Governing Equations of GFD. 1.1 Mass continuity

Chapter 1. Governing Equations of GFD. 1.1 Mass continuity Chapter 1 Governing Equations of GFD The fluid dynamical governing equations consist of an equation for mass continuity, one for the momentum budget, and one or more additional equations to account for

More information

Dissipation and Dispersion

Dissipation and Dispersion Consider the problem with periodic boundary conditions Dissipation and Dispersion u t = au x 0 < x < 1, t > 0 u 0 = sin 40 πx u(0, t) = u(1, t) t > 0 If a > 0 then the wave is moving to the left and if

More information

A stochastic particle system for the Burgers equation.

A stochastic particle system for the Burgers equation. A stochastic particle system for the Burgers equation. Alexei Novikov Department of Mathematics Penn State University with Gautam Iyer (Carnegie Mellon) supported by NSF Burgers equation t u t + u x u

More information

Part 1. The diffusion equation

Part 1. The diffusion equation Differential Equations FMNN10 Graded Project #3 c G Söderlind 2016 2017 Published 2017-11-27. Instruction in computer lab 2017-11-30/2017-12-06/07. Project due date: Monday 2017-12-11 at 12:00:00. Goals.

More information

Numerical Heat and Mass Transfer

Numerical Heat and Mass Transfer Master Degree in Mechanical Engineering Numerical Heat and Mass Transfer 15-Convective Heat Transfer Fausto Arpino f.arpino@unicas.it Introduction In conduction problems the convection entered the analysis

More information

GFD 2012 Lecture 1: Dynamics of Coherent Structures and their Impact on Transport and Predictability

GFD 2012 Lecture 1: Dynamics of Coherent Structures and their Impact on Transport and Predictability GFD 2012 Lecture 1: Dynamics of Coherent Structures and their Impact on Transport and Predictability Jeffrey B. Weiss; notes by Duncan Hewitt and Pedram Hassanzadeh June 18, 2012 1 Introduction 1.1 What

More information

A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws

A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws A. A. I. Peer a,, A. Gopaul a, M. Z. Dauhoo a, M. Bhuruth a, a Department of Mathematics, University of Mauritius, Reduit,

More information

n v molecules will pass per unit time through the area from left to

n v molecules will pass per unit time through the area from left to 3 iscosity and Heat Conduction in Gas Dynamics Equations of One-Dimensional Gas Flow The dissipative processes - viscosity (internal friction) and heat conduction - are connected with existence of molecular

More information

Chapter 7: Natural Convection

Chapter 7: Natural Convection 7-1 Introduction 7- The Grashof Number 7-3 Natural Convection over Surfaces 7-4 Natural Convection Inside Enclosures 7-5 Similarity Solution 7-6 Integral Method 7-7 Combined Natural and Forced Convection

More information

Diffusion of a density in a static fluid

Diffusion of a density in a static fluid Diffusion of a density in a static fluid u(x, y, z, t), density (M/L 3 ) of a substance (dye). Diffusion: motion of particles from places where the density is higher to places where it is lower, due to

More information

What is a flux? The Things We Does Know

What is a flux? The Things We Does Know What is a flux? Finite Volume methods (and others) (are based on ensuring conservation by computing the flux through the surfaces of a polyhedral box. Either the normal component of the flux is evaluated

More information

Figure XP3.1 (a) Mass in equilibrium, (b) Freebody diagram, (c) Kinematic constraint relation Example Problem 3.1 Figure XP3.1 illustrates a mass m

Figure XP3.1 (a) Mass in equilibrium, (b) Freebody diagram, (c) Kinematic constraint relation Example Problem 3.1 Figure XP3.1 illustrates a mass m LECTURE 7. MORE VIBRATIONS ` Figure XP3.1 (a) Mass in equilibrium, (b) Freebody diagram, (c) Kinematic constraint relation Example Problem 3.1 Figure XP3.1 illustrates a mass m that is in equilibrium and

More information

Computational Fluid Dynamics-1(CFDI)

Computational Fluid Dynamics-1(CFDI) بسمه تعالی درس دینامیک سیالات محاسباتی 1 دوره کارشناسی ارشد دانشکده مهندسی مکانیک دانشگاه صنعتی خواجه نصیر الدین طوسی Computational Fluid Dynamics-1(CFDI) Course outlines: Part I A brief introduction to

More information

3 Generation and diffusion of vorticity

3 Generation and diffusion of vorticity Version date: March 22, 21 1 3 Generation and diffusion of vorticity 3.1 The vorticity equation We start from Navier Stokes: u t + u u = 1 ρ p + ν 2 u 1) where we have not included a term describing a

More information

2 A: The Shallow Water Equations

2 A: The Shallow Water Equations 2 A: The Shallow Water Equations 2.1 Surface motions on shallow water Consider two-dimensional (x-z) motions on a nonrotating, shallow body of water, of uniform density, as shown in Fig. 1 below. The ow

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

Partial differential equations

Partial differential equations Partial differential equations Many problems in science involve the evolution of quantities not only in time but also in space (this is the most common situation)! We will call partial differential equation

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

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 660-Lecture 23: Gudonov s method and some theories for FVM schemes

Math 660-Lecture 23: Gudonov s method and some theories for FVM schemes Math 660-Lecture 3: Gudonov s method and some theories for FVM schemes 1 The idea of FVM (You can refer to Chapter 4 in the book Finite volume methods for hyperbolic problems ) Consider the box [x 1/,

More information

CHAPTER 4 BOUNDARY LAYER FLOW APPLICATION TO EXTERNAL FLOW

CHAPTER 4 BOUNDARY LAYER FLOW APPLICATION TO EXTERNAL FLOW CHAPTER 4 BOUNDARY LAYER FLOW APPLICATION TO EXTERNAL FLOW 4.1 Introduction Boundary layer concept (Prandtl 1904): Eliminate selected terms in the governing equations Two key questions (1) What are the

More information

Mathematical Hydrodynamics

Mathematical Hydrodynamics Mathematical Hydrodynamics Ya G. Sinai 1. Introduction Mathematical hydrodynamics deals basically with Navier-Stokes and Euler systems. In the d-dimensional case and incompressible fluids these are the

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

Finite Volume Schemes: an introduction

Finite Volume Schemes: an introduction Finite Volume Schemes: an introduction First lecture Annamaria Mazzia Dipartimento di Metodi e Modelli Matematici per le Scienze Applicate Università di Padova mazzia@dmsa.unipd.it Scuola di dottorato

More information

Solving the Euler Equations!

Solving the Euler Equations! http://www.nd.edu/~gtryggva/cfd-course/! Solving the Euler Equations! Grétar Tryggvason! Spring 0! The Euler equations for D flow:! where! Define! Ideal Gas:! ρ ρu ρu + ρu + p = 0 t x ( / ) ρe ρu E + p

More information

Collision of inertial particles in turbulent flows.

Collision of inertial particles in turbulent flows. Collision of inertial particles in turbulent flows. Alain Pumir, INLN (France) Grisha Falkovich, Weizmann Inst. (Israel) Introduction (1) Particles advected by a fluid flow, with a mass that does not match

More information

isocurvature modes Since there are two degrees of freedom in

isocurvature modes Since there are two degrees of freedom in isocurvature modes Since there are two degrees of freedom in the matter-radiation perturbation, there must be a second independent perturbation mode to complement the adiabatic solution. This clearly must

More information

Introduction to the Finite Volumes Method. Application to the Shallow Water Equations. Jaime Miguel Fe Marqués

Introduction to the Finite Volumes Method. Application to the Shallow Water Equations. Jaime Miguel Fe Marqués Introduction to the Finite Volumes Method. Application to the Shallow Water Equations. Jaime Miguel Fe Marqués Contents Preliminary considerations 3. Study of the movement of a fluid................ 3.

More information

Numerical Methods for Engineers and Scientists

Numerical Methods for Engineers and Scientists Numerical Methods for Engineers and Scientists Second Edition Revised and Expanded Joe D. Hoffman Department of Mechanical Engineering Purdue University West Lafayette, Indiana m MARCEL D E К К E R MARCEL

More information

Finite difference method for solving Advection-Diffusion Problem in 1D

Finite difference method for solving Advection-Diffusion Problem in 1D Finite difference method for solving Advection-Diffusion Problem in 1D Author : Osei K. Tweneboah MATH 5370: Final Project Outline 1 Advection-Diffusion Problem Stationary Advection-Diffusion Problem in

More information

An Introduction to Theories of Turbulence. James Glimm Stony Brook University

An Introduction to Theories of Turbulence. James Glimm Stony Brook University An Introduction to Theories of Turbulence James Glimm Stony Brook University Topics not included (recent papers/theses, open for discussion during this visit) 1. Turbulent combustion 2. Turbulent mixing

More information

B.1 NAVIER STOKES EQUATION AND REYNOLDS NUMBER. = UL ν. Re = U ρ f L μ

B.1 NAVIER STOKES EQUATION AND REYNOLDS NUMBER. = UL ν. Re = U ρ f L μ APPENDIX B FLUID DYNAMICS This section is a brief introduction to fluid dynamics. Historically, a simplified concept of the boundary layer, the unstirred water layer, has been operationally used in the

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

F11AE1 1. C = ρν r r. r u z r

F11AE1 1. C = ρν r r. r u z r F11AE1 1 Question 1 20 Marks) Consider an infinite horizontal pipe with circular cross-section of radius a, whose centre line is aligned along the z-axis; see Figure 1. Assume no-slip boundary conditions

More information

Basic Aspects of Discretization

Basic Aspects of Discretization Basic Aspects of Discretization Solution Methods Singularity Methods Panel method and VLM Simple, very powerful, can be used on PC Nonlinear flow effects were excluded Direct numerical Methods (Field Methods)

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

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

BAE 820 Physical Principles of Environmental Systems

BAE 820 Physical Principles of Environmental Systems BAE 820 Physical Principles of Environmental Systems Stokes' law and Reynold number Dr. Zifei Liu The motion of a particle in a fluid environment, such as air or water m dv =F(t) - F dt d - 1 4 2 3 πr3

More information

( ) II. Why statistics? SIO 221B, Rudnick adapted from Davis!1

( ) II. Why statistics? SIO 221B, Rudnick adapted from Davis!1 SIO 221B, Rudnick adapted from Davis 1 II. Why statistics? This course addresses the analysis of oceanographic observations and, as they become more complex, ocean models. Much of the material involves

More information