Streamline calculations. Lecture note 2

Size: px
Start display at page:

Download "Streamline calculations. Lecture note 2"

Transcription

1 Streamline calculations. Lecture note 2 February 26, Recapitulation from previous lecture Definition of a streamline x(τ) = s(τ), dx(τ) dτ = v(x,t), x(0) = x 0 (1) Divergence free, irrotational flow in 2D: v can be expressed as the gradient of a potential: v = φ (2) where φ is the real part of the (analytic) complex potential The streamlines are level curves of ψ(x,y): F(z) = φ(x,y) + iψ(x,y) (3) ψ(x,y) = const (4) Divergence free flow in 2D: Streamline are still level curves of a streamfunction. An explicit formula for the streamfunction is ( ) dvy ψ(x,y) = v x dy v y dx + dy dx dy For divergence free flow in 3D, two independent streamfunctions will exist, such that their intersection describe a streamline. The streamfunctions in 3D seems to be more complicated and less useful in applications than the stream function in 2D. 1

2 2 Integration (continued from previous lecture) Linear system of equations Note: In this section we assume that the velocity is independent of time, i.e., v(x,t) = v(x). Then path lines and streamlines are the same; hence, it is not significant to distinguish between τ and t in Equation (1). Thus in this section, we use x(t) to represent a streamline, which is consistent with the notation used in text books on ordinary differential equations. Assume that v : R n R n is linear in space, such that the equation for the streamline becomes, dx dt = v = Ax + b x(0) = x 0, (5) where A is a constant n n matrix, and b is a constant n 1 vector. Assume further, that A has n linearly independent eigenvectors ξ i, with corresponding eigenvalues λ i, i = 1,...,n. Note: if A does not have a set of n linearly independent eigenvectors, it is more involved, but still possible to find an analytic solution. We now define the matrices λ T = [ ] 0 λ 2 0 ξ 1... ξ n, D =......, (6) 0 0 λ n corresponding to the eigenvalue decomposition AT = T D. By using the substitution x = T x, Equation (5) becomes T d x dt = AT x + b x(0) = T 1 x 0 x 0, (7) and a decoupled equation in x is obtained by multiplication by T 1, d x dt = D x + T 1 b x(0) = x 0 (8) The last equation can be written in component form d x i dt = λ i x i + α i, x i (0) = x 0 i, i = 1,...,n, (9) which are easily integrated. The true solution x(t) is recovered by x(t) = T x(t) (10) 2

3 Example Let x = [x,y] T and v = [ x 2y +1,3x+4y 1] T and x 0 = [2, 3] T. Then [ ] [ ] A =, b =, (11) and λ 1 = 1, λ 2 = 2, ξ 1 = [1, 1] T, and ξ 2 = [2, 3] T. Hence, [ ] [ ] [ ] 1 2 T = T = D =. (12) Then T 1 b = [ ] 1, x 0 0 = T 1 x 0 = [ ] 0 1 (13) and letting x = [ x, ỹ], we have ] d x [ x + 1 dt = 2ỹ x(t) = [ C5 e t ] 1 C 6 e 2t, (14) and x(0) = x 0 = [ ] 0 1 x(t) = [ e t ] 1 e 2t, (15) and finally x(t) = T x(t) x(t) = [ e t + 2e 2t ] 1 e t 3e 2t + 1 (16) See Figure 1 Numerical integration Methods for numerical integration of initial value problems (IVP) for ordinary differential equations (ODE) include : Taylor series Euler s method Heun s method Runge-Kutta methods Adam s methods The methods can be further classified with respect to 3

4 Figure 1: Field plot for v = [ x 2y + 1,3x + 4y 1] T. A streamline s(τ) is started at s(0) = s 0 = [2, 3] and traced backward in time to the point s( 0.5). Single-step / multi-step method Explict / implicit method. We will here consider a second order Runge-Kutta method, for the model problem: dx dt = f(x) x(0) = x 0. (17) Since the right-hand side in general don t need to be a velocity, we have used f(x) instead of v(x). Choose a fixed time step t. We will compute a numerical solution at discrete points t i, i = 1,...,N, such that t i+1 t i = t. The approximate solution at time t i, is denoted x i. Integration of (17) 4

5 now gives x(t) = x 0 + t 0 f(x)dt x(t n+1 ) = x(t n + t) = x 0 + Approximate tn+1 x n + x n + t n tn+1 t n f(x)dt f(x n+1/2 )dt We then have the numerical scheme: tn x n+1/2 x n + (t n+1/2 t n ) dx dt 0 = x n + t 2 f(x n) tn+1 f(x)dt + f(x)dt t n (18) tn x n+1 = x n + tf(x n + t 2 f(x n)) (19) Note: Matlab has a variety of solvers for initial value promblems for ordinary differential equations, e.g. ode45 and ode23, which have automatic error control. A minimal MATLAB implementation Example Let v = [cos(xy),x], and x 0 = [ 1,1]. See Figure 2. A minimal MATLAB implementation for this velocity field could be: function rktest() [t, y] = rk2(@vel, [0,3], [-1; 1], 0.01); return function y=vel(x) y(1,1)=cos(x(1,1)*x(2,1)); y(2,1)=x(1,1); return function [tout, yout] = rk2(yprime, tspan, y0, dt) t0=tspan(1); 5

6 Figure 2: Field plot for v = [cos(xy),x]. A streamline s(τ) is started at s(0) = s 0 = [ 1,1], and traced to the point s(3). tn=tspan(2); N = floor((tn-t0)/dt) + 1; tout = linspace(t0,tn,n) ; h=tout(2)-tout(1); yout = zeros(n,size(y0,1)); yout(1,:) = y0 ; y=y0; for i=2:n k=yprime(y); y = y + h*yprime(y + (h/2)*k); yout(i,:) = y ; end return 3 Reservoir simulation Reservoir simulation is the numerical solution of the partial differential equations describing the flow in a porous media. Ideally, the flow equations could be derived from conservation of mass and momentum (and energy for compressible flow) for an infinitesimal 6

7 volume of fluid. This would lead to the Navier-Stokes equations, which relates change of volume to pressure change and viscous forces. However, for flow in porous media (like an oil reservoir), these equation would become impossible to solve since we typically don t now the exact shape of the pores. We therefore employ an average concept, using the Darcy s law, which will replace the momentum equation. Darcy s law is a phenomologically derived constitutive equation. The equation was originally formulated by Henry Darcy based on the results of experiments on the flow of water through beds of sand. 3.1 Two phase immiscible flow We will consider a simple model problem, where we consider two immiscible phases oil and water. Darcy s law then reads where q α = k rα µ α K( P α ρ α g), α = o,w, (20) q α are the specific discharge vectors (commonly denoted the Darcy velocity) K is the permeability tensor k rα are the realtive permabilities, µ α are the viscosities, ρ α are the densities, g is the gravity vector, P α are the phase pressures. The Darcy velocity is related to the average particle velocity v α for phase α through q α = φv α, (21) See Figure 3. Let S α denote the fraction of the volume occupied by phase α at a given point in the reservoir. 7

8 Figure 3: Cross section of a porous medium. White areas indicates pores, whereas the cross hatched area denotes the matrix. To obtain the average particle velocity normal to the cross section, we devide the total fluid flux through the pores (white area) by the area of the pores (white area). To obtain the Darcy velocity, we devide the flux by the total area of the cross section (sum of white area and cross hatched area). Conservation of mass is applied over a control volume V, to derive the continuity equation. The conservation principle for volume V says that Accumulated Fluid + Flow out of V = Injected fluid (22) Mathematically this is expressed as (φρ α S α )dv + (ρ α q t α ) nds = Q α (23) V V t (φρ αs α ) + (ρ α q α ) = Q α, (24) where Q α is the source term for phase α. In addition, we have the constitutive relations (equations of state). S w + S o = 1 (25) P o P w = P c (S w ) (26) ρ α = ρ α (P w ) (27) µ α = µ α (P w ) (28) k rα = k rα (S w ) (29) In addition, the porosity and the permeability must be known: φ = φ(x,t) (30) K = K(x,t) (31) 8

9 By inserting the Darcy velocity in (24), a formulation of the flow equations common for use with finite difference methods is obtained: t (φρ αs α ) + ( ρ α k rα µ α K( P α ρ α g)) = Q α, α = o,w (32) This is a system of two nonlinear equations in two unknowns, e.g., P w and S w. These equations can be solved numerically by finite difference methods. A pressure/saturation formulation We will reformulate the last equations into one pressure equation (elliptic) and one saturation equation (hyperbolic). In this way, it will be easier to discover the porperties of the equations, and we can obtain a faster numerical solution procedure. To obtain the pressure equation, we begin with expanding the time derivatives in (32), where φ t ρ αs α + φ ρ α t S S α α + φρ α + (ρ α q t α ) = Q α (33) φ t S 1 ρ α α + φs α ρ α t + φ S α + 1 (ρ α q t ρ α ) = Q α α ρ α (34) φ t S P α α + φs α c α + φ S α + 1 (ρ α q t t ρ α ) = Q α, α ρ α (35) c α = 1 ρ α ρ α P α (36) Adding the two equations in (35), and using (25), we get ( ) φ t + φ P w P o S w c w + S o c o + t t 1 (ρ w q ρ w ) + 1 (ρ o q w ρ o ) = Q w + Q o, (37) o ρ w ρ o where we have eliminated the time derivatives of the saturations. This last equation is denoted the pressure equation. We now start by deriving the saturation equation. Define λ α = k rα µ α (38) 9

10 Introduce the total velocity q, q = q w + q o = λ w K( P w ρ w g) λ o K( P o ρ o g) (39) We will first express the water velocity in terms of the total velocity. From Darcy s law we have q o = λ o K( P o ρ o g) K P o = 1 λ o q o + ρ o Kg (40) q w = λ w K( P w ρ w g) K P w = 1 λ w q w ρ w Kg (41) adding these equations gives K P c = 1 λ o q o + 1 λ w q w + (ρ o ρ w )Kg (42) By using (39) to eliminate q o, we get ( ) q λ o λ w = 1 q + K P c + (ρ w ρ o )Kg (43) w λ o By defining we get h w (S w ) = λ oλ w λ o + λ w (44) f w (S w ) = λ w, λ o + λ w (45) q w = f w q + h w K( P c + (ρ w ρ o )g) (46) Saturation equation. By inserting (46) into Equation (24) t (φρ ws w ) + (ρ w (f w q + h w K( P c + (ρ w ρ o )g))) = Q w (47) 3.2 Simplified two-phase flow To ease the discussion of what follows, we simplfy the the problem by assuming, Incompressible fluids (ρ w, ρ o are constant) Time independent porosity ( φ/ t = 0) No capillary pressure (P o = P w = P) No gravity (g = 0) 10

11 The flow equations (37) and (47) now simplifies to q = Q w ρ w + Q o ρ o (48) φ S w t + (f w q) = Q w ρ w (49) Defining λ t = λ w + λ o, and using Equation (39), we have q = q w + q o = λ w K P λ o K P = λ t K P, (50) and the pressure equation (48) can be written ( λ t K P) = Q w ρ w + Q o ρ o (51) It follows from (48) that q = 0, away from sources and sinks. In this case the saturation equation (49) becomes φ S w t + q f w = 0 (52) 3.3 Simplification using streamlines and time-of-flight Within streamline simulation, the streamline parameter τ is denoted the time-of-flight (TOF). In some applications of streamline simulation, arrival times of particles along streamlines will be important. Since these particles travel with the average particle velocity, and not with the Darcy velocity, we will relate the time of flight to the average particle velocity. Hence, we define streamlines s(τ) = x(τ) and TOF by We also have: τ(s) = dx dτ = q(x,t), x(0) = x 0 (53) φ dx dτ = ds dτ = ds dτ ds dτ = q φ s 0 = ds dτ (54) (55) φ q ds (56) From the previous equation, we also have the differential form q s = φ τ, (57) 11

12 We now return to Equation (52). Using the previous relation and the definition of a directional derivative, we get q f w = q f w s = φ f w τ (58) Hence, by using streamlines and time-of-flight, we can simplify (52) as S w t + f w(s w ) τ = 0 (59) Note the two different meanings of t and τ in the last equation. We have simplified the saturation equation to a 1D hyperbolic equation along streamlines. References 12

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

Chapter 9: Differential Analysis

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

More information

Chapter 9: Differential Analysis of Fluid Flow

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

More information

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

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

More information

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

Fourth Order RK-Method

Fourth Order RK-Method Fourth Order RK-Method The most commonly used method is Runge-Kutta fourth order method. The fourth order RK-method is y i+1 = y i + 1 6 (k 1 + 2k 2 + 2k 3 + k 4 ), Ordinary Differential Equations (ODE)

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

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

Worksheet 8 Sample Solutions

Worksheet 8 Sample Solutions Technische Universität München WS 2016/17 Lehrstuhl für Informatik V Scientific Computing Univ.-Prof. Dr. M. Bader 19.12.2016/21.12.2016 M.Sc. S. Seckler, M.Sc. D. Jarema Worksheet 8 Sample Solutions Ordinary

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

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

Logistic Map, Euler & Runge-Kutta Method and Lotka-Volterra Equations

Logistic Map, Euler & Runge-Kutta Method and Lotka-Volterra Equations Logistic Map, Euler & Runge-Kutta Method and Lotka-Volterra Equations S. Y. Ha and J. Park Department of Mathematical Sciences Seoul National University Sep 23, 2013 Contents 1 Logistic Map 2 Euler and

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

Initial Value Problems

Initial Value Problems Numerical Analysis, lecture 13: Initial Value Problems (textbook sections 10.1-4, 10.7) differential equations standard form existence & uniqueness y 0 y 2 solution methods x 0 x 1 h h x 2 y1 Euler, Heun,

More information

Lecture 42 Determining Internal Node Values

Lecture 42 Determining Internal Node Values Lecture 42 Determining Internal Node Values As seen in the previous section, a finite element solution of a boundary value problem boils down to finding the best values of the constants {C j } n, which

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

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

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

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

More information

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

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

dynamics of f luids in porous media

dynamics of f luids in porous media dynamics of f luids in porous media Jacob Bear Department of Civil Engineering Technion Israel Institute of Technology, Haifa DOVER PUBLICATIONS, INC. New York Contents Preface xvii CHAPTER 1 Introduction

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

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

- 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

A PSEUDO FUNCTION APPROACH IN RESERVOIR SIMULATION

A PSEUDO FUNCTION APPROACH IN RESERVOIR SIMULATION INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume 2, Supp, Pages 58 67 c 2005 Institute for Scientific Computing and Information A PSEUDO FUNCTION APPROACH IN RESERVOIR SIMULATION ZHANGXIN

More information

AE/ME 339. K. M. Isaac Professor of Aerospace Engineering. 12/21/01 topic7_ns_equations 1

AE/ME 339. K. M. Isaac Professor of Aerospace Engineering. 12/21/01 topic7_ns_equations 1 AE/ME 339 Professor of Aerospace Engineering 12/21/01 topic7_ns_equations 1 Continuity equation Governing equation summary Non-conservation form D Dt. V 0.(2.29) Conservation form ( V ) 0...(2.33) t 12/21/01

More information

Seminar zu aktuellen Themen der Numerik im Wintersemester 2010/2011

Seminar zu aktuellen Themen der Numerik im Wintersemester 2010/2011 Seminar zu aktuellen Themen der Numerik im Wintersemester 2010/2011 Modeling Two-Phase-Two-Component Processes in Porous Media Using an Upscaling-Multi-Scale Method Elin Solberg 27 January 2011 Contents

More information

Derivation of the fractional flow equation for a one-dimensional oil-water system. Consider displacement of oil by water in a system of dip angle α

Derivation of the fractional flow equation for a one-dimensional oil-water system. Consider displacement of oil by water in a system of dip angle α TPG45 Reservoir Recovery Techniques 27 /9 BUCKLEY-LEVERETT ANALYSIS Derivation of the fractional flow equation for a one-dimensional oil-water system Consider displacement of oil by water in a system of

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

Todd Arbogast. Department of Mathematics and Center for Subsurface Modeling, Institute for Computational Engineering and Sciences (ICES)

Todd Arbogast. Department of Mathematics and Center for Subsurface Modeling, Institute for Computational Engineering and Sciences (ICES) CONSERVATIVE CHARACTERISTIC METHODS FOR LINEAR TRANSPORT PROBLEMS Todd Arbogast Department of Mathematics and, (ICES) The University of Texas at Austin Chieh-Sen (Jason) Huang Department of Applied Mathematics

More information

Scientific Computing with Case Studies SIAM Press, Lecture Notes for Unit V Solution of

Scientific Computing with Case Studies SIAM Press, Lecture Notes for Unit V Solution of Scientific Computing with Case Studies SIAM Press, 2009 http://www.cs.umd.edu/users/oleary/sccswebpage Lecture Notes for Unit V Solution of Differential Equations Part 1 Dianne P. O Leary c 2008 1 The

More information

Examination paper for TMA4195 Mathematical Modeling

Examination paper for TMA4195 Mathematical Modeling Department of Mathematical Sciences Examination paper for TMA4195 Mathematical Modeling Academic contact during examination: Espen R. Jakobsen Phone: 73 59 35 12 Examination date: December 16, 2017 Examination

More information

AE301 Aerodynamics I UNIT B: Theory of Aerodynamics

AE301 Aerodynamics I UNIT B: Theory of Aerodynamics AE301 Aerodynamics I UNIT B: Theory of Aerodynamics ROAD MAP... B-1: Mathematics for Aerodynamics B-: Flow Field Representations B-3: Potential Flow Analysis B-4: Applications of Potential Flow Analysis

More information

ME 509, Spring 2016, Final Exam, Solutions

ME 509, Spring 2016, Final Exam, Solutions ME 509, Spring 2016, Final Exam, Solutions 05/03/2016 DON T BEGIN UNTIL YOU RE TOLD TO! Instructions: This exam is to be done independently in 120 minutes. You may use 2 pieces of letter-sized (8.5 11

More information

Initial value problems for ordinary differential equations

Initial value problems for ordinary differential equations AMSC/CMSC 660 Scientific Computing I Fall 2008 UNIT 5: Numerical Solution of Ordinary Differential Equations Part 1 Dianne P. O Leary c 2008 The Plan Initial value problems (ivps) for ordinary differential

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

1 Modeling Immiscible Fluid Flow in Porous Media

1 Modeling Immiscible Fluid Flow in Porous Media Excerpts from the Habilitation Thesis of Peter Bastian. For references as well as the full text, see http://cox.iwr.uni-heidelberg.de/people/peter/pdf/bastian_habilitationthesis.pdf. Used with permission.

More information

Again we will consider the following one dimensional slab of porous material:

Again we will consider the following one dimensional slab of porous material: page 1 of 7 REVIEW OF BASIC STEPS IN DERIVATION OF FLOW EQUATIONS Generally speaking, flow equations for flow in porous materials are based on a set of mass, momentum and energy conservation equations,

More information

Introduction to Fluid Mechanics

Introduction to Fluid Mechanics Introduction to Fluid Mechanics Tien-Tsan Shieh April 16, 2009 What is a Fluid? The key distinction between a fluid and a solid lies in the mode of resistance to change of shape. The fluid, unlike the

More information

Cyber-Physical Systems Modeling and Simulation of Continuous Systems

Cyber-Physical Systems Modeling and Simulation of Continuous Systems Cyber-Physical Systems Modeling and Simulation of Continuous Systems Matthias Althoff TU München 29. May 2015 Matthias Althoff Modeling and Simulation of Cont. Systems 29. May 2015 1 / 38 Ordinary Differential

More information

REDUCING ORDER METHODS APPLIED TO RESERVOIR SIMULATION

REDUCING ORDER METHODS APPLIED TO RESERVOIR SIMULATION REDUCING ORDER METHODS APPLIED TO RESERVOIR SIMULATION Lindaura Maria Steffens Dara Liandra Lanznaster lindaura.steffens@udesc.br daraliandra@gmail.com Santa Catarina State University CESFI, Av. Central,

More information

3.5 Vorticity Equation

3.5 Vorticity Equation .0 - Marine Hydrodynamics, Spring 005 Lecture 9.0 - Marine Hydrodynamics Lecture 9 Lecture 9 is structured as follows: In paragraph 3.5 we return to the full Navier-Stokes equations (unsteady, viscous

More information

A FRONT-TRACKING METHOD FOR HYPERBOLIC THREE-PHASE MODELS

A FRONT-TRACKING METHOD FOR HYPERBOLIC THREE-PHASE MODELS A FRONT-TRACKING METHOD FOR HYPERBOLIC THREE-PHASE MODELS Ruben Juanes 1 and Knut-Andreas Lie 2 1 Stanford University, Dept. Petroleum Engineering, USA 2 SINTEF IKT, Dept., Norway ECMOR IX, August 30 September

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

Continuum Mechanics Lecture 5 Ideal fluids

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

More information

Local Time Step for a Finite Volume Scheme I.Faille F.Nataf*, F.Willien, S.Wolf**

Local Time Step for a Finite Volume Scheme I.Faille F.Nataf*, F.Willien, S.Wolf** Controlled CO 2 Diversified fuels Fuel-efficient vehicles Clean refining Extended reserves Local Time Step for a Finite Volume Scheme I.Faille F.Nataf*, F.Willien, S.Wolf** *: Laboratoire J.L.Lions **:Université

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

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

Introduction to standard and non-standard Numerical Methods

Introduction to standard and non-standard Numerical Methods Introduction to standard and non-standard Numerical Methods Dr. Mountaga LAM AMS : African Mathematic School 2018 May 23, 2018 One-step methods Runge-Kutta Methods Nonstandard Finite Difference Scheme

More information

Understand the existence and uniqueness theorems and what they tell you about solutions to initial value problems.

Understand the existence and uniqueness theorems and what they tell you about solutions to initial value problems. Review Outline To review for the final, look over the following outline and look at problems from the book and on the old exam s and exam reviews to find problems about each of the following topics.. Basics

More information

This report shows the capabilities of Tdyn for modelling the fluid flow through porous media.

This report shows the capabilities of Tdyn for modelling the fluid flow through porous media. Flow through porous media 1 Flow through porous media Introduction This report shows the capabilities of Tdyn for modelling the fluid flow through porous media. Modelling approach Modeling of flows through

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

Exam in TMA4195 Mathematical Modeling Solutions

Exam in TMA4195 Mathematical Modeling Solutions Norwegian University of Science and Technology Department of Mathematical Sciences Page of 9 Exam in TMA495 Mathematical Modeling 6..07 Solutions Problem a Here x, y are two populations varying with time

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

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 7

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 7 Numerical Fluid Mechanics Fall 2011 Lecture 7 REVIEW of Lecture 6 Material covered in class: Differential forms of conservation laws Material Derivative (substantial/total derivative) Conservation of Mass

More information

Identification Methods for Structural Systems. Prof. Dr. Eleni Chatzi Lecture March, 2016

Identification Methods for Structural Systems. Prof. Dr. Eleni Chatzi Lecture March, 2016 Prof. Dr. Eleni Chatzi Lecture 4-09. March, 2016 Fundamentals Overview Multiple DOF Systems State-space Formulation Eigenvalue Analysis The Mode Superposition Method The effect of Damping on Structural

More information

Consistency and Convergence

Consistency and Convergence Jim Lambers MAT 77 Fall Semester 010-11 Lecture 0 Notes These notes correspond to Sections 1.3, 1.4 and 1.5 in the text. Consistency and Convergence We have learned that the numerical solution obtained

More information

A MULTISCALE METHOD FOR MODELING TRANSPORT IN POROUS MEDIA ON UNSTRUCTURED CORNER-POINT GRIDS

A MULTISCALE METHOD FOR MODELING TRANSPORT IN POROUS MEDIA ON UNSTRUCTURED CORNER-POINT GRIDS A MULTISCALE METHOD FOR MODELING TRANSPORT IN POROUS MEDIA ON UNSTRUCTURED CORNER-POINT GRIDS JØRG E. AARNES AND YALCHIN EFENDIEV Abstract. methods are currently under active investigation for the simulation

More information

ECE257 Numerical Methods and Scientific Computing. Ordinary Differential Equations

ECE257 Numerical Methods and Scientific Computing. Ordinary Differential Equations ECE257 Numerical Methods and Scientific Computing Ordinary Differential Equations Today s s class: Stiffness Multistep Methods Stiff Equations Stiffness occurs in a problem where two or more independent

More information

Applications of Partial Differential Equations in Reservoir Simulation

Applications of Partial Differential Equations in Reservoir Simulation P-32 Applications of Partial Differential Equations in Reservoir Simulation Deepak Singh Summary The solution to stochastic partial differential equations may be viewed in several manners. One can view

More information

Chapter 6: Incompressible Inviscid Flow

Chapter 6: Incompressible Inviscid Flow Chapter 6: Incompressible Inviscid Flow 6-1 Introduction 6-2 Nondimensionalization of the NSE 6-3 Creeping Flow 6-4 Inviscid Regions of Flow 6-5 Irrotational Flow Approximation 6-6 Elementary Planar Irrotational

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

The Divergence Theorem Stokes Theorem Applications of Vector Calculus. Calculus. Vector Calculus (III)

The Divergence Theorem Stokes Theorem Applications of Vector Calculus. Calculus. Vector Calculus (III) Calculus Vector Calculus (III) Outline 1 The Divergence Theorem 2 Stokes Theorem 3 Applications of Vector Calculus The Divergence Theorem (I) Recall that at the end of section 12.5, we had rewritten Green

More information

Viscous Fluids. Amanda Meier. December 14th, 2011

Viscous Fluids. Amanda Meier. December 14th, 2011 Viscous Fluids Amanda Meier December 14th, 2011 Abstract Fluids are represented by continuous media described by mass density, velocity and pressure. An Eulerian description of uids focuses on the transport

More information

Homework #4 Solution. μ 1. μ 2

Homework #4 Solution. μ 1. μ 2 Homework #4 Solution 4.20 in Middleman We have two viscous liquids that are immiscible (e.g. water and oil), layered between two solid surfaces, where the top boundary is translating: y = B y = kb y =

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

Polytechnic Institute of NYU MA 2132 Final Practice Answers Fall 2012

Polytechnic Institute of NYU MA 2132 Final Practice Answers Fall 2012 Polytechnic Institute of NYU MA Final Practice Answers Fall Studying from past or sample exams is NOT recommended. If you do, it should be only AFTER you know how to do all of the homework and worksheet

More information

Physics 584 Computational Methods

Physics 584 Computational Methods Physics 584 Computational Methods Introduction to Matlab and Numerical Solutions to Ordinary Differential Equations Ryan Ogliore April 18 th, 2016 Lecture Outline Introduction to Matlab Numerical Solutions

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

I. Borsi. EMS SCHOOL ON INDUSTRIAL MATHEMATICS Bedlewo, October 11 18, 2010

I. Borsi. EMS SCHOOL ON INDUSTRIAL MATHEMATICS Bedlewo, October 11 18, 2010 : an : an (Joint work with A. Fasano) Dipartimento di Matematica U. Dini, Università di Firenze (Italy) borsi@math.unifi.it http://web.math.unifi.it/users/borsi porous EMS SCHOOL ON INDUSTRIAL MATHEMATICS

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

2 GOVERNING EQUATIONS

2 GOVERNING EQUATIONS 2 GOVERNING EQUATIONS 9 2 GOVERNING EQUATIONS For completeness we will take a brief moment to review the governing equations for a turbulent uid. We will present them both in physical space coordinates

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

Differential Equations

Differential Equations Differential Equations Overview of differential equation! Initial value problem! Explicit numeric methods! Implicit numeric methods! Modular implementation Physics-based simulation An algorithm that

More information

R.M. Manasipov and J.E. Mindel. Montanuniversitaet Leoben. October 3, 2014

R.M. Manasipov and J.E. Mindel. Montanuniversitaet Leoben. October 3, 2014 Comparative Analysis of Compositional Two-Phase Flow Modeling in Heterogeneous Media Between the Discrete Event Simulation Method Coupled to a Split Node Formulation and Classical Timestep-Driven Approaches

More information

RATE OF FLUID FLOW THROUGH POROUS MEDIA

RATE OF FLUID FLOW THROUGH POROUS MEDIA RATE OF FLUID FLOW THROUGH POROUS MEDIA Submitted by Xu Ming Xin Kiong Min Yi Kimberly Yip Juen Chen Nicole A project presented to the Singapore Mathematical Society Essay Competition 2013 1 Abstract Fluid

More information

Lecture 4: Numerical solution of ordinary differential equations

Lecture 4: Numerical solution of ordinary differential equations Lecture 4: Numerical solution of ordinary differential equations Department of Mathematics, ETH Zürich General explicit one-step method: Consistency; Stability; Convergence. High-order methods: Taylor

More information

Numerical Methods - Initial Value Problems for ODEs

Numerical Methods - Initial Value Problems for ODEs Numerical Methods - Initial Value Problems for ODEs Y. K. Goh Universiti Tunku Abdul Rahman 2013 Y. K. Goh (UTAR) Numerical Methods - Initial Value Problems for ODEs 2013 1 / 43 Outline 1 Initial Value

More information

Chapter 8. Numerical Solution of Ordinary Differential Equations. Module No. 2. Predictor-Corrector Methods

Chapter 8. Numerical Solution of Ordinary Differential Equations. Module No. 2. Predictor-Corrector Methods Numerical Analysis by Dr. Anita Pal Assistant Professor Department of Matematics National Institute of Tecnology Durgapur Durgapur-7109 email: anita.buie@gmail.com 1 . Capter 8 Numerical Solution of Ordinary

More information

The Navier-Stokes Equations

The Navier-Stokes Equations s University of New Hampshire February 22, 202 and equations describe the non-relativistic time evolution of mass and momentum in fluid substances. mass density field: ρ = ρ(t, x, y, z) velocity field:

More information

KINEMATICS OF CONTINUA

KINEMATICS OF CONTINUA KINEMATICS OF CONTINUA Introduction Deformation of a continuum Configurations of a continuum Deformation mapping Descriptions of motion Material time derivative Velocity and acceleration Transformation

More information

Modeling of two-phase flow in fractured porous media on unstructured non-uniform coarse grids

Modeling of two-phase flow in fractured porous media on unstructured non-uniform coarse grids Modeling of two-phase flow in fractured porous media on unstructured non-uniform coarse grids Jørg Espen Aarnes and Vera Louise Hauge SINTEF ICT, Deptartment of Applied Mathematics Applied Mathematics

More information

Review of fluid dynamics

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

More information

ACM/CMS 107 Linear Analysis & Applications Fall 2016 Assignment 4: Linear ODEs and Control Theory Due: 5th December 2016

ACM/CMS 107 Linear Analysis & Applications Fall 2016 Assignment 4: Linear ODEs and Control Theory Due: 5th December 2016 ACM/CMS 17 Linear Analysis & Applications Fall 216 Assignment 4: Linear ODEs and Control Theory Due: 5th December 216 Introduction Systems of ordinary differential equations (ODEs) can be used to describe

More information

HW6. 1. Book problems 8.5, 8.6, 8.9, 8.23, 8.31

HW6. 1. Book problems 8.5, 8.6, 8.9, 8.23, 8.31 HW6 1. Book problems 8.5, 8.6, 8.9, 8.3, 8.31. Add an equal strength sink and a source separated by a small distance, dx, and take the limit of dx approaching zero to obtain the following equations for

More information

On the origin of Darcy s law 1

On the origin of Darcy s law 1 Chapter 1 On the origin of Darcy s law 1 Cyprien Soulaine csoulain@stanford.edu When one thinks about porous media, the immediate concepts that come to mind are porosity, permeability and Darcy s law.

More information

CHAPTER 4 ANALYTICAL SOLUTIONS OF COUPLE STRESS FLUID FLOWS THROUGH POROUS MEDIUM BETWEEN PARALLEL PLATES WITH SLIP BOUNDARY CONDITIONS

CHAPTER 4 ANALYTICAL SOLUTIONS OF COUPLE STRESS FLUID FLOWS THROUGH POROUS MEDIUM BETWEEN PARALLEL PLATES WITH SLIP BOUNDARY CONDITIONS CHAPTER 4 ANALYTICAL SOLUTIONS OF COUPLE STRESS FLUID FLOWS THROUGH POROUS MEDIUM BETWEEN PARALLEL PLATES WITH SLIP BOUNDARY CONDITIONS Introduction: The objective of this chapter is to establish analytical

More information

COURSE NUMBER: ME 321 Fluid Mechanics I 3 credit hour. Basic Equations in fluid Dynamics

COURSE NUMBER: ME 321 Fluid Mechanics I 3 credit hour. Basic Equations in fluid Dynamics COURSE NUMBER: ME 321 Fluid Mechanics I 3 credit hour Basic Equations in fluid Dynamics Course teacher Dr. M. Mahbubur Razzaque Professor Department of Mechanical Engineering BUET 1 Description of Fluid

More information

Ordinary Differential Equations

Ordinary Differential Equations Ordinary Differential Equations Michael H. F. Wilkinson Institute for Mathematics and Computing Science University of Groningen The Netherlands December 2005 Overview What are Ordinary Differential Equations

More information

Fluid Dynamics: Theory, Computation, and Numerical Simulation Second Edition

Fluid Dynamics: Theory, Computation, and Numerical Simulation Second Edition Fluid Dynamics: Theory, Computation, and Numerical Simulation Second Edition C. Pozrikidis m Springer Contents Preface v 1 Introduction to Kinematics 1 1.1 Fluids and solids 1 1.2 Fluid parcels and flow

More information

( ) and then eliminate t to get y(x) or x(y). Not that the

( ) and then eliminate t to get y(x) or x(y). Not that the 2. First-order linear equations We want the solution (x,y) of () ax, ( y) x + bx, ( y) y = 0 ( ) and b( x,y) are given functions. If a and b are constants, then =F(bx-ay) where ax, y where F is an arbitrary

More information

Mathematics Qualifying Exam Study Material

Mathematics Qualifying Exam Study Material Mathematics Qualifying Exam Study Material The candidate is expected to have a thorough understanding of engineering mathematics topics. These topics are listed below for clarification. Not all instructors

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

Numerical Differential Equations: IVP

Numerical Differential Equations: IVP Chapter 11 Numerical Differential Equations: IVP **** 4/16/13 EC (Incomplete) 11.1 Initial Value Problem for Ordinary Differential Equations We consider the problem of numerically solving a differential

More information

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 1 / 31 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS Linearization and Characteristic Relations 1 / 31 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

More information

MA3D1 Fluid Dynamics Support Class 5 - Shear Flows and Blunt Bodies

MA3D1 Fluid Dynamics Support Class 5 - Shear Flows and Blunt Bodies MA3D1 Fluid Dynamics Support Class 5 - Shear Flows and Blunt Bodies 13th February 2015 Jorge Lindley email: J.V.M.Lindley@warwick.ac.uk 1 2D Flows - Shear flows Example 1. Flow over an inclined plane A

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

Darcy's Law. Laboratory 2 HWR 531/431

Darcy's Law. Laboratory 2 HWR 531/431 Darcy's Law Laboratory HWR 531/431-1 Introduction In 1856, Henry Darcy, a French hydraulic engineer, published a report in which he described a series of experiments he had performed in an attempt to quantify

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

Several forms of the equations of motion

Several forms of the equations of motion Chapter 6 Several forms of the equations of motion 6.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