Hq = f + ψ is the absolute vorticity. If we further assume a flat bottom then we can re-write the equations as

Size: px
Start display at page:

Download "Hq = f + ψ is the absolute vorticity. If we further assume a flat bottom then we can re-write the equations as"

Transcription

1 Lecture Barotropic equations 8. Barotropic equations The barotropic equations describe balanced motion in a two-dimensional incrompessible homogeneous fluid. A quick (and dirty) derivation involves imposing a rigid-lid on the shallow water equations; the vorticity and continuity equation are then: ρ t (Hq) + ρ x (Hqu) + ρ y (Hqv) = 0 (8.) ρ x (Hu) + ρ y (Hv) = 0. (8.) Hq = f + ψ is the absolute vorticity. If we further assume a flat bottom then we can re-write the equations as ρ t ψ + J(τ, f + ψ) = 0 (8.3) ψ = τ (8.4) v = ρ x τ (8.5) u = ρ y τ (8.6) where ψ is the relative vorticty and τ is a stream-function. J(p, q) is the Jacobian operator J(p, q) = ρ x pρ y q ρ y pρ x q which may also be written in flux form as J(p, q) = ρ x (pρ y q) ρ y (pρ x q) 0

2 .950 Atmospheric and Oceanic odeling, Spring or as J(p, q) = ρ y (qρ x p) ρ x (qρ y p) Because of these flux forms, if either p or q is either zero or constant on the boundary of a domain then the domain integral of J(p, q) dx dy = 0. Further, < pj(p, q) > = < J( p, q) >= 0 < qj(p, q) > = < J(p, q ) >= 0 These properties imply that domain integrated kinetic energy, τ, and enstrophy, f + ψ, are conserved. We ll consider three approaches to solving the barotropic equations numerically. For pragmatic purposes we must include friction and viscosity; hte most typical form of the barotropic equation is ρ t ψ + J(τ, ψ) + ωρ x τ = F ζψ + ψ (8.7) where F is a general forcing and other terms on the R.H.S. are arbitrary forms of dissipation; ζ is a (bottom) drag coefficient and is a lateral viscosity. The model is forced by a wind-stress curl, F = τ which is prescribed. The model domain may be either a doubly periodic domain, a channel or a bounded box with no normal flow on the sides which means that the stream function is constant on the boundary: and no-slip at the side walls: τ = 0 on boundaries (8.8) τ ˆn = 0 on boundaries (8.9) 8. Finite difference barotropic model We ll describe a finite difference approximation to the above equations for the purposes of comparison. We ll use the leap-frog method for advection (the Jacobian term) and a forward method for the dissipation terms: ( ) ψ n+ = ψ n + t F J n B n + D n (8.0)

3 .950 Atmospheric and Oceanic odeling, Spring where F is the forcing term, J n and B n are the Jacobian and beta terms evaluated at the mid-point, n, and D n is the dissipation terms evaluated at the past point, n. The dissipation terms are discretized in space using second order finite differences: β 3 β 3 D n = ζψ n + β ii ψ n + β y jj ψ n (8.) x The beta term is a centered second order difference: The vorticity is discretized: i B n = β i τ n (8.) x ψ n = ωy ij + β ii ψ n + y β jj ψ n (8.3) x The treatment of the Jacobian term will be desribed in the next section. The complete algorithm then is as follows: from ψ n, compute τ n by inverting τ n = ψ n, compute the Jacobian J n = J(τ n, ψ n ) compute the dissipation D n compute ψ n+ = ψ n + t(f J n B n + D n ) increment n and repeat cycle and at some interval, say every 50 steps, after computing ψ n+ we will filter out the leap-frog computational mode by setting ψ n = (ψ n+ + ψ n )/. 8.3 The Arakawa Jacobian Fig. 8. shows a grid with labels for the stencil of points involved in the simplest finite difference Jacobians proposed by Arakawa, 960. Using these labels, the Jacobians evaluated at point 5 are defined x yj ++ = (τ 8 τ )(ψ 7 ψ 4 ) (τ 6 τ 3 )(ψ 7 ψ 0 ) x yj + = τ 8 (ψ 7 ψ 4 ) τ (ψ 0 ψ ) τ 6 (ψ 7 ψ 0 ) + τ 3 (ψ 4 ψ ) x yj + = ψ 6 (τ 7 τ 0 ) ψ 3 (τ 4 τ ) ψ 8 (τ 7 τ 4 ) + ψ (τ 0 τ )

4 .950 Atmospheric and Oceanic odeling, Spring Figure 8.: The stencil of points for evaluating the Arakawa Jacobians; evaluation at point 5 involves contributions from points 0 through 7 and evaluation at point 7 involves contributions from points 5 through 3. The blue cross indicates the stencil of points of the + terms and the red indicates the stencil of points of the terms, both at point 5. The continuum energy equation is found by multiplying the vorticity equation by τ and noting that < τj(τ, ψ) >= 0. Consider the contributions to the energy equation arising from τ 5 J +5 and τ 7 J +7 : τ 5 J +5 = τ 5 ψ 6 τ 7 τ 5 ψ 6 τ 0 τ 5 ψ 3 τ 4 + τ 5 ψ 3 τ τ 5 ψ 8 τ 7 + τ 5 ψ 8 τ 4 + τ 5 ψ τ 0 τ 5 ψ τ τ 7 J +7 = τ 7 ψ τ τ 7 ψ τ 3 τ 7 ψ 8 τ 9 + τ 7 ψ 8 τ 5 τ 7 ψ 0 τ + τ 7 ψ 0 τ 9 + τ 7 ψ 6 τ 3 τ 7 ψ 6 τ 5 We see that the underlined terms appear in both contributions with the opposite sign so that they cancel; summing over all points, all terms cancel in a similar fashion. It follows that J + globally conserves energy and it follows by symmetry that J + globally conserves enstrophy. However, similar consideration of the contributions from ψj + shows that there is no such cancellation: ψ 5 J +5 = ψ 5 ψ 6 τ 7 ψ 5 ψ 6 τ 0 ψ 5 ψ 3 τ 4 + ψ 5 ψ 3 τ

5 .950 Atmospheric and Oceanic odeling, Spring ψ 5 ψ 8 τ 7 + ψ 5 ψ 8 τ 4 + ψ 5 ψ τ 0 ψ 5 ψ τ ψ 7 J +7 = ψ 7 ψ τ ψ 7 ψ τ 3 ψ 7 ψ 8 τ 9 + τ 7 ψ 8 τ 5 ψ 7 ψ 0 τ + ψ 7 ψ 0 τ 9 + ψ 7 ψ 6 τ 3 ψ 7 ψ 6 τ 5 There is only one term with the quantity ψ 5 ψ 6 τ 7 and so nothing can cancel it. However, the J ++ conserves neither but it happens that The most obvious discretization of the Jacobian: ( J ++ (τ, ψ) = β i τ i β j ψ j β j τ j β i ψ i) (8.4) x y corresponds to the continuum form, J(τ, ψ) = ρ x τρ y ψ ρ y τρ x ψ. The flux form Jacobian ( i J + (τ, ψ) = β i (τβ j ψ j ) β j (τβ i ψ ij ) (8.5) x y corresponds to the continuum form, J(τ, ψ) = ρ x (τρ y ψ) ρ y (τρ x ψ) and the other flux form Jacobian ( i J + (τ, ψ) = β j (ψβ i τ ij ) β i (ψβ j τ j ) (8.6) x y corresponds to the continuum form, J(τ, ψ) = ρ y (ψρ x τ) ρ x (ψρ y τ). In the fashion shown above, Arakawa, 960, showed that J + conserves the integral of enstrophy, ψ, (J ++ + J + ) conserves the integral of enstrophy, ψ, J + conserves the integral of energy, τ τ, (J ++ + J + ) conserves the integral of energy, τ τ, so that the famous combination of J n = (J ++ + J + + J + ) 3 conserves both the enstrophy and energy and therefore also conserves mean wave number; this prevents nonlinear instability occurring.

6 .950 Atmospheric and Oceanic odeling, Spring Solving elliptic boundary value problems In the preceding finite difference model, we had to solve a problem of the form τ = ψ given some boundary conditions on τ (e.g. τ = 0). One approach is to note that the solution to the above elliptic problem is the steady state solution to the following time-dependent ρ t τ = τ ψ This is simply a diffusion problem with a source term and can be solved use simple explicit method with an appropriately chosen time-step. Consider the FTCS discretization t ( ) τ n+ = τ n + τ n i,j + τn tψ x i,j + τ i n +,j + τn i,j+ 4τ i,j This system can be integrated forward in a stable fashion so long as t x. If we chose the largest time-step then the system simplifies to 4 τ n+ ( ) n n x = τ ψ 4 i,j + τ i +,j + τi,j n + τi,j+ n 4 which is known as Jacobi s method. The method converges but converges slowly. A slightly more efficient iterative method is the Gauss-Seidel method which uses the latest estimates on the RHS as the computations procede. A commonly used GS method is known as the red-black Guass-Seidel method where the points on the grid are labelled in a checker-board fashion (redblack). The Jacobi method is applied to the red and black points seperately, using the latest values in each consecutive copmutation. A more efficient iterative method is successive over-relaxation (SOR) which is described in some detail in Numerical Recipes, chapter 9. For the recast problem n a i,j τ i,j + b n i,j τ i +,j + c i,j τi,j n + d i,j τi,j+ n + e i,j τ i,j = ψ

7 .950 Atmospheric and Oceanic odeling, Spring the SOR algorithm is where ( ) τ n = ψ a i,j τ i,j b n i,j τ i +,j c i,j τi,j n d i,j τi,j+ n ei,j τi,j n+ = φτi,j + ( φ)τi,j n φ 0 = φ = ( ρ J acobi ) φ n = ( φ n ρ J acobi) n =, 3,... 4 and ρ J acobi is a function of a, b, c, d and e. The original elliptic problem can be solved directly by Fourier analysis. Suppose we have Dirichlet boundary conditions (τ = 0 on the boundaries) then a natural basis function is sine waves. The solution is represented by the Fourier series and N νik νjl τ i,j = a k,l sin sin N k= l= N νik νjl ψ i,j = b k,l sin sin N k= l= This allows us to solve the elliptic problem by first computing N νik νjl b k,l = ψ i,j sin sin N i= j= N and then for each Fourier mode ( ν(i )k νjl ν(i + )k νjl a k,l sin sin + sin sin N N νik ν(j )l νik ν(j + )l + sin sin + sin sin N N νjl νjl νjl νjl 4 sin sin = b k,l sin sin

8 .950 Atmospheric and Oceanic odeling, Spring or or simply ( a k,l ( cos νk N +( cos νl ) sin νik N ) sin νik N 4 sin νjl sin νjl sin νjl sin νjl = b k,l sin νjl sin νjl a k,l = b k,l cos πk + cos πk 4 N N 8.5 Finite element barotropic model We ll now solve the barotropic equations using the Galerkin approximation. The basis function must now be two-dimensional. Since we are in a rectangular domain, we can use a square based function known as the pagoda function: x x i y y i φ ij (x, y) = max(0, ( )( )) x y which gives bi-linear interpolation between values on a quadrilateral grid. The result of the Galerkin approximation is: 3 3 ω i β β β i τ A x A y ρ t ψ + J + A y = ζa x A y ψ A y β ii ψ A x β jj ψ (8.7) x x y The operator A x A y is a two-dimensional operator and thus potentially expensive to invert but since it is separable into two tri-diagonal operators we can invert it relatively efficiently. The Jacobian term is the complicated term to calculate. The Galerkin approximation is: J = φ ij ρ x τρ y ψ dx dy φ ij ρ y τρ x ψ dx dy Substituting in the series expansions τ = τ k,l φ k,l (x, y) k,l ψ = ψ m,n φ m,n (x, y) m,n

9 .950 Atmospheric and Oceanic odeling, Spring 04 0 into the first integral in J gives dx dy φ ij τ k,l ρ x φ k,l (x, y) ψ m,n ρ y φ m,n (x, y) k,l m,n Since the pagoda functions only interact with the eight neighboring elements the summations reduce to sums over k = i, i, i + ; l = j, j, j + ; m = i, i, i + ; n = j, j, j + we can anticipate up to 9 9 = 8 coefficients arising from the double sum. Fortunately, many of these are zero since some of the pairs of basis functions, (k, l) and (m, n) don t overlap (e.g. (k, l) = (i, j ) and (m, n) = (i +, j + )). Others can be deduced to be zero by symmetry, for example, dx dyφ i,j ρ x φ i,j+ ρ y φ i,j+ = 0. However, rather than compute all these coefficients we can make an inspired guess based on the structures of the other terms: i j i x yj = A y β i τ A x β j ψ j A x β j τ A y β i ψ If we use the leap-frog scheme for the Jacobian and beta terms and forward method for the dissipation terms then our model algorithm is: δ3 δ3 A x y compute D n = A x A y ζψ n y β ii ψ n A x β jj ψ n i compute B n = A x β i τ n ( i j i compute J ) n = x A y y β i τ A x β j ψ A x β j τ j A y β i ψ invert A x A y ρ t ψ = F J n B n + D n step forward for ψ n+ = ψ n + tρ t ψ increment n and repeat cycle An alternative approach is to invert the equation so that each term requires a matrix solve. ultiply through by the inverse of A x A y : β 3 β 3 ρ t q = J A x βi τ i ζq A x β ii q x x A y y β jj q

10 .950 Atmospheric and Oceanic odeling, Spring 04 Now, solve And then the Jacobian can be appriximated as and similarly the beta term is and dissipation term i A x ρ x τ = β i τ (8.8) x A y ρ τ y = β j τ j (8.9) y A x ρ β i q i x q = (8.0) x A y ρ β j q j y q = (8.) y A y ρ xx q = β ii q (8.) x A y ρ yy q = β jj q (8.3) y J = ρ x τ ρ y q ρ τ ρ x q y B τ = ρ x D = β 3 (ρ xxq + ρ yy q ) This method is the method of compact differencing and is gives fourth order accuracy. The prognostic equation then becomes ( ) q n+ B n + D n = q n + t F J n 8.5. Spectral and pseudo-spectral barotropic model For simplicity, we will limit ourselves to a doubly periodic domain or dimensions ν by ν. This reduces the number of coefficients in the following model. Using fourier basis functions and the Galerkin method we can obtain the differential equation for the spectral coefficients (k + l )ρ t a kl + ( ) ωik + ζ(k + l ) + (k + l ) a kl = φ k (x)φ l (y)(f J ) da Ikkll

11 .950 Atmospheric and Oceanic odeling, Spring 04 where I kkll = I kk I ll and I nk = φ n (x)φ k (x) dx noting that I nk = 0 n = k because φ k (x) = e ikx form an orthogonal set of basis functions. In the spectral method, the fourier transform of J leads to a convolution and is relatively expensive to evaluate. The transform method is the more efficient approach in which J is evaluated in physical space and the transformed to wave-number space: τ x (x i, y j ) = τ y (x i, y j ) = ψ x (x i, y j ) = ψ y (x i, y j ) = ika kl e ikx i e ily j k l ilakl e ikx i e ily j k l ik(k + l )a kl e ikx i e ily j k l il(k + l )a kl e ikx i e ily j k l J(x i, y i ) = τx ψ y τ y ψ x J kl = J(x i, y j )e ikx i e ily j N F kl = N i j so that we can now integrate ( ) (k + l )ρ t a kl + ωik + ζ(k + l ) + (k + l ) a kl = F kl J kl i j F (x i, y j )e ikx i e ily j Note that the left hand side can be integrated in time analytically but that some explicit and stable time-stepping method must be used for the right hand side Aliasing and nonlinear aliasing Discrete representations of functions always allow aliasing of unresolved wave numbers onto resolved numbers. Fig. 8. shows an example using the regular finite difference grid x j = νj/n with N = 8. Evaluating the function cos(5x) at x j (black) only on the finite difference grid gives the eight values indicated by the circles. The highest mode that can be resolved on this grid is

12 .950 Atmospheric and Oceanic odeling, Spring 04 3 cos(3x), cos(7x) & cos(x) x/(*π) Figure 8.: Aliasing of high wave number to a low wave number on a finite resolution grid: the grid has 8 nodes and on that grid, cos(5x) (solid black)is indistinguishable (circles) from cos(3x) (dashed blue). The highest mode that could be represented is cos 4x. The mode cos(x) (red) is also aliased to cos(3x). cos( N x) = cos(4x) and all higher mode number waves are mis-represented on this grid. In this case, cos(5x) is aliased to cos(3x); evaluating the function cos(3x) on the finite difference grid gives the exact same values as from cos(5x). ore generally, the relation ikx j ikj x iπn ikj x i(k+ πn )j x i(k+ πn )x e = e = e e = e x = e x j n = 0, ±, ±,... means that a resolved mode k can result in aliasing an infinite set of modes k + νn/ x. In the above example, with x = ν/8, n = corresponds to cos(5x) and n = corresponds to cos(x). Non-linear instability can occur when the result of nonlinear interactions between two waves result in higher mode number waves that can not be represented on the grid. The aliasing of these unresolved waves implies a false source of energy at lower wave numbers. Thus, if nonlinear interactions

13 .950 Atmospheric and Oceanic odeling, Spring 04 4 cos(3x), cos(4x) & cos(3x)cos(4x) x/(*π) Figure 8.3: Nonlinear instability occurs when the product of two resolved waves leads to a high mode number component that can not be resolved by the grid and is aliased to lower resolved waves. Here, we show the same 8 point grid with the functions cos(3x) (blue circles) and cos(5x) (red circles) and their product cos 3x cos 5x = cos(8 x) + cos( x) (black squares) which has a cos(8x) component that aliases to cos(x). produces a wave number k + k > N/, then it will falsely appear as k 3 = N (k + k ). We illustrate this in Fig. 8.3 in which the product of cos(3x) and cos(4x) on an 8-point grid results in a higher mode signal with

Barotropic geophysical flows and two-dimensional fluid flows: Conserved Quantities

Barotropic geophysical flows and two-dimensional fluid flows: Conserved Quantities Barotropic geophysical flows and two-dimensional fluid flows: Conserved Quantities Di Qi, and Andrew J. Majda Courant Institute of Mathematical Sciences Fall 2016 Advanced Topics in Applied Math Di Qi,

More information

Lab 8. October 25, Laboratory 8: Solution of the Quasi-geostrophic Equations using an Implicit Scheme

Lab 8. October 25, Laboratory 8: Solution of the Quasi-geostrophic Equations using an Implicit Scheme Lab 8 October 25, 205 Laboratory 8: Solution of the Quasi-geostrophic Equations using an Implicit Scheme Lin Yang & John M. Stockie Contents List of Problems. Objectives 2. Readings 3. Introduction 4.

More information

LES of Turbulent Flows: Lecture 3

LES of Turbulent Flows: Lecture 3 LES of Turbulent Flows: Lecture 3 Dr. Jeremy A. Gibbs Department of Mechanical Engineering University of Utah Fall 2016 1 / 53 Overview 1 Website for those auditing 2 Turbulence Scales 3 Fourier transforms

More information

A Truncated Model for Finite Amplitude Baroclinic Waves in a Channel

A Truncated Model for Finite Amplitude Baroclinic Waves in a Channel A Truncated Model for Finite Amplitude Baroclinic Waves in a Channel Zhiming Kuang 1 Introduction To date, studies of finite amplitude baroclinic waves have been mostly numerical. The numerical models,

More information

Chapter 4. Nonlinear Hyperbolic Problems

Chapter 4. Nonlinear Hyperbolic Problems Chapter 4. Nonlinear Hyperbolic Problems 4.1. Introduction Reading: Durran sections 3.5-3.6. Mesinger and Arakawa (1976) Chapter 3 sections 6-7. Supplementary reading: Tannehill et al sections 4.4 and

More information

Engineering. Spring Department of Fluid Mechanics, Budapest University of Technology and Economics. Large-Eddy Simulation in Mechanical

Engineering. Spring Department of Fluid Mechanics, Budapest University of Technology and Economics. Large-Eddy Simulation in Mechanical Outline Geurts Book Department of Fluid Mechanics, Budapest University of Technology and Economics Spring 2013 Outline Outline Geurts Book 1 Geurts Book Origin This lecture is strongly based on the book:

More information

Introduction to Heat and Mass Transfer. Week 9

Introduction to Heat and Mass Transfer. Week 9 Introduction to Heat and Mass Transfer Week 9 補充! Multidimensional Effects Transient problems with heat transfer in two or three dimensions can be considered using the solutions obtained for one dimensional

More information

Chapter 3. Stability theory for zonal flows :formulation

Chapter 3. Stability theory for zonal flows :formulation Chapter 3. Stability theory for zonal flows :formulation 3.1 Introduction Although flows in the atmosphere and ocean are never strictly zonal major currents are nearly so and the simplifications springing

More information

Chapter 5. Methods for Solving Elliptic Equations

Chapter 5. Methods for Solving Elliptic Equations Chapter 5. Methods for Solving Elliptic Equations References: Tannehill et al Section 4.3. Fulton et al (1986 MWR). Recommended reading: Chapter 7, Numerical Methods for Engineering Application. J. H.

More information

Laboratory #8: Solution of the Quasi-geostrophic Equations using an Implicit Scheme

Laboratory #8: Solution of the Quasi-geostrophic Equations using an Implicit Scheme Laboratory #8: Solution of the Quasi-geostrophic Equations using an Implicit Scheme Lin Yang & John M. Stockie Date printed: November 11, 2009 Contents List of Problems 1 1 Objectives 1 2 Readings 2 3

More information

ECE539 - Advanced Theory of Semiconductors and Semiconductor Devices. Numerical Methods and Simulation / Umberto Ravaioli

ECE539 - Advanced Theory of Semiconductors and Semiconductor Devices. Numerical Methods and Simulation / Umberto Ravaioli ECE539 - Advanced Theory of Semiconductors and Semiconductor Devices 1 General concepts Numerical Methods and Simulation / Umberto Ravaioli Introduction to the Numerical Solution of Partial Differential

More information

Advection in two dimensions

Advection in two dimensions Lecture 0 Advection in two dimensions 6. Stability of multiple terms (in multiple dimensions) When we analyzed the stability of time-stepping methods we tended to consider either a single damping term

More information

Lecture 1. Taylor series and finite differences. 1.1 Representation of functions

Lecture 1. Taylor series and finite differences. 1.1 Representation of functions Lecture Taylor series and finite differences To numerically solve continuous differential equations we must first define how to represent a continuous function by a finite set of numbers, f j with j =,,...,

More information

Thomas Pierro, Donald Slinn, Kraig Winters

Thomas Pierro, Donald Slinn, Kraig Winters Thomas Pierro, Donald Slinn, Kraig Winters Department of Ocean Engineering, Florida Atlantic University, Boca Raton, Florida Applied Physics Laboratory, University of Washington, Seattle, Washington Supported

More information

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

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

More information

Stability of Shear Flow

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

More information

Statistical Mechanics for the Truncated Quasi-Geostrophic Equations

Statistical Mechanics for the Truncated Quasi-Geostrophic Equations Statistical Mechanics for the Truncated Quasi-Geostrophic Equations Di Qi, and Andrew J. Majda Courant Institute of Mathematical Sciences Fall 6 Advanced Topics in Applied Math Di Qi, and Andrew J. Majda

More information

Computational Design for Long-Term Numerical Integration of the Equations of Fluid Motion: Two-Dimensional Incompressible Flow.

Computational Design for Long-Term Numerical Integration of the Equations of Fluid Motion: Two-Dimensional Incompressible Flow. JOURNAL OF COMPUTATIONAL PHYSICS 135, 103 114 (1997) ARTICLE NO. CP975697 Computational Design for Long-Term Numerical Integration of the Equations of Fluid Motion: Two-Dimensional Incompressible Flow.

More information

Math 5630: Iterative Methods for Systems of Equations Hung Phan, UMass Lowell March 22, 2018

Math 5630: Iterative Methods for Systems of Equations Hung Phan, UMass Lowell March 22, 2018 1 Linear Systems Math 5630: Iterative Methods for Systems of Equations Hung Phan, UMass Lowell March, 018 Consider the system 4x y + z = 7 4x 8y + z = 1 x + y + 5z = 15. We then obtain x = 1 4 (7 + y z)

More information

The Shallow Water Equations

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

More information

Chapter 4. MAC Scheme. The MAC scheme is a numerical method used to solve the incompressible Navier-Stokes. u = 0

Chapter 4. MAC Scheme. The MAC scheme is a numerical method used to solve the incompressible Navier-Stokes. u = 0 Chapter 4. MAC Scheme 4.1. MAC Scheme and the Staggered Grid. The MAC scheme is a numerical method used to solve the incompressible Navier-Stokes equation in the velocity-pressure formulation: (4.1.1)

More information

Non-linear Stability of Steady Geophysical Flows

Non-linear Stability of Steady Geophysical Flows Non-linear Stability of Steady Geophysical Flows Di Qi, and Andrew J. Majda Courant Institute of Mathematical Sciences Fall 2016 Advanced Topics in Applied Math Di Qi, and Andrew J. Majda (CIMS) Non-linear

More information

An Overly Simplified and Brief Review of Differential Equation Solution Methods. 1. Some Common Exact Solution Methods for Differential Equations

An Overly Simplified and Brief Review of Differential Equation Solution Methods. 1. Some Common Exact Solution Methods for Differential Equations An Overly Simplified and Brief Review of Differential Equation Solution Methods We will be dealing with initial or boundary value problems. A typical initial value problem has the form y y 0 y(0) 1 A typical

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

Navier-Stokes equations

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

More information

ME Computational Fluid Mechanics Lecture 5

ME Computational Fluid Mechanics Lecture 5 ME - 733 Computational Fluid Mechanics Lecture 5 Dr./ Ahmed Nagib Elmekawy Dec. 20, 2018 Elliptic PDEs: Finite Difference Formulation Using central difference formulation, the so called five-point formula

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

1. Nonlinear Equations. This lecture note excerpted parts from Michael Heath and Max Gunzburger. f(x) = 0

1. Nonlinear Equations. This lecture note excerpted parts from Michael Heath and Max Gunzburger. f(x) = 0 Numerical Analysis 1 1. Nonlinear Equations This lecture note excerpted parts from Michael Heath and Max Gunzburger. Given function f, we seek value x for which where f : D R n R n is nonlinear. f(x) =

More information

BALANCED FLOW: EXAMPLES (PHH lecture 3) Potential Vorticity in the real atmosphere. Potential temperature θ. Rossby Ertel potential vorticity

BALANCED FLOW: EXAMPLES (PHH lecture 3) Potential Vorticity in the real atmosphere. Potential temperature θ. Rossby Ertel potential vorticity BALANCED FLOW: EXAMPLES (PHH lecture 3) Potential Vorticity in the real atmosphere Need to introduce a new measure of the buoyancy Potential temperature θ In a compressible fluid, the relevant measure

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

Finite Volume Method for Scalar Advection in 2D

Finite Volume Method for Scalar Advection in 2D Chapter 9 Finite Volume Method for Scalar Advection in D 9. Introduction The purpose of this exercise is to code a program to integrate the scalar advection equation in two-dimensional flows. 9. The D

More information

The Convergence of Mimetic Discretization

The Convergence of Mimetic Discretization The Convergence of Mimetic Discretization for Rough Grids James M. Hyman Los Alamos National Laboratory T-7, MS-B84 Los Alamos NM 87545 and Stanly Steinberg Department of Mathematics and Statistics University

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

Finite Difference Methods for Boundary Value Problems

Finite Difference Methods for Boundary Value Problems Finite Difference Methods for Boundary Value Problems October 2, 2013 () Finite Differences October 2, 2013 1 / 52 Goals Learn steps to approximate BVPs using the Finite Difference Method Start with two-point

More information

Introduction to Heat and Mass Transfer. Week 7

Introduction to Heat and Mass Transfer. Week 7 Introduction to Heat and Mass Transfer Week 7 Example Solution Technique Using either finite difference method or finite volume method, we end up with a set of simultaneous algebraic equations in terms

More information

Problem Set Number 01, MIT (Winter-Spring 2018)

Problem Set Number 01, MIT (Winter-Spring 2018) Problem Set Number 01, 18.306 MIT (Winter-Spring 2018) Rodolfo R. Rosales (MIT, Math. Dept., room 2-337, Cambridge, MA 02139) February 28, 2018 Due Monday March 12, 2018. Turn it in (by 3PM) at the Math.

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

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

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs Chapter Two: Numerical Methods for Elliptic PDEs Finite Difference Methods for Elliptic PDEs.. Finite difference scheme. We consider a simple example u := subject to Dirichlet boundary conditions ( ) u

More information

Number of pages in the question paper : 06 Number of questions in the question paper : 48 Modeling Transport Phenomena of Micro-particles Note: Follow the notations used in the lectures. Symbols have their

More information

Computational Techniques Prof. Sreenivas Jayanthi. Department of Chemical Engineering Indian institute of Technology, Madras

Computational Techniques Prof. Sreenivas Jayanthi. Department of Chemical Engineering Indian institute of Technology, Madras Computational Techniques Prof. Sreenivas Jayanthi. Department of Chemical Engineering Indian institute of Technology, Madras Module No. # 05 Lecture No. # 24 Gauss-Jordan method L U decomposition method

More information

Eddy PV Fluxes in a One Dimensional Model of Quasi-Geostrophic Turbulence

Eddy PV Fluxes in a One Dimensional Model of Quasi-Geostrophic Turbulence Eddy PV Fluxes in a One Dimensional Model of Quasi-Geostrophic Turbulence Christos M.Mitas Introduction. Motivation Understanding eddy transport of heat and momentum is crucial to developing closure schemes

More information

Multi-Point Special Boundary-Value Problems and Applications to Fluid Flow Through Porous Media

Multi-Point Special Boundary-Value Problems and Applications to Fluid Flow Through Porous Media Multi-Point Special Boundary-Value Problems and Applications to Fluid Flow Through Porous Media Mohamed A. Hajji Abstract In this paper we propose a numerical scheme based on finite differences for the

More information

Time-dependent variational forms

Time-dependent variational forms Time-dependent variational forms Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Oct 30, 2015 PRELIMINARY VERSION

More information

Linear Advection Equation

Linear Advection Equation Linear Advection Equation Numerical Methods Laboratory Modelling the Climate System ARC Centre of Excellence for Climate System Science 2nd Annual Winter School 18 June 2013 1 Analytical Solution The linear

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

The need for de-aliasing in a Chebyshev pseudo-spectral method

The need for de-aliasing in a Chebyshev pseudo-spectral method The need for de-aliasing in a Chebyshev pseudo-spectral method Markus Uhlmann Potsdam Institut für Klimafolgenforschung, D-442 Potsdam uhlmann@pik-potsdam.de (March 2) Abstract In the present report, we

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

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Introduction Deng Li Discretization Methods Chunfang Chen, Danny Thorne, Adam Zornes CS521 Feb.,7, 2006 What do You Stand For? A PDE is a Partial Differential Equation This

More information

) 2 ψ +β ψ. x = 0. (71) ν = uk βk/k 2, (74) c x u = β/k 2. (75)

) 2 ψ +β ψ. x = 0. (71) ν = uk βk/k 2, (74) c x u = β/k 2. (75) 3 Rossby Waves 3.1 Free Barotropic Rossby Waves The dispersion relation for free barotropic Rossby waves can be derived by linearizing the barotropic vortiticy equation in the form (21). This equation

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

Aspects of Multigrid

Aspects of Multigrid Aspects of Multigrid Kees Oosterlee 1,2 1 Delft University of Technology, Delft. 2 CWI, Center for Mathematics and Computer Science, Amsterdam, SIAM Chapter Workshop Day, May 30th 2018 C.W.Oosterlee (CWI)

More information

Problem Set Number 01, MIT (Winter-Spring 2018)

Problem Set Number 01, MIT (Winter-Spring 2018) Problem Set Number 01, 18.377 MIT (Winter-Spring 2018) Rodolfo R. Rosales (MIT, Math. Dept., room 2-337, Cambridge, MA 02139) February 28, 2018 Due Thursday, March 8, 2018. Turn it in (by 3PM) at the Math.

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

Kasetsart University Workshop. Multigrid methods: An introduction

Kasetsart University Workshop. Multigrid methods: An introduction Kasetsart University Workshop Multigrid methods: An introduction Dr. Anand Pardhanani Mathematics Department Earlham College Richmond, Indiana USA pardhan@earlham.edu A copy of these slides is available

More information

Solutions to Laplace s Equation in Cylindrical Coordinates and Numerical solutions. ρ + (1/ρ) 2 V

Solutions to Laplace s Equation in Cylindrical Coordinates and Numerical solutions. ρ + (1/ρ) 2 V Solutions to Laplace s Equation in Cylindrical Coordinates and Numerical solutions Lecture 8 1 Introduction Solutions to Laplace s equation can be obtained using separation of variables in Cartesian and

More information

PDEs, part 1: Introduction and elliptic PDEs

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

More information

Boundary Layers: Homogeneous Ocean Circulation

Boundary Layers: Homogeneous Ocean Circulation Boundary Layers: Homogeneous Ocean irculation Lecture 7 by Angel Ruiz-Angulo The first explanation for the western intensification of the wind-driven ocean circulation was provided by Henry Stommel (948).

More information

Mixed Mimetic Spectral Elements for Geophysical Fluid Dynamics

Mixed Mimetic Spectral Elements for Geophysical Fluid Dynamics for Geophysical Fluid Dynamics Dave Lee Los Alamos National Laboratory Outline Connection of finite volumes to differential forms Key ideas of differential forms Differential forms for discrete data Construction

More information

The Spectral Method (MAPH 40260)

The Spectral Method (MAPH 40260) The Spectral Method (MAPH 40260) Part 4: Barotropic Vorticity Equation Peter Lynch School of Mathematical Sciences Outline Background Rossby-Haurwitz Waves Interaction Coefficients Transform Method The

More information

kg meter ii) Note the dimensions of ρ τ are kg 2 velocity 2 meter = 1 sec 2 We will interpret this velocity in upcoming slides.

kg meter ii) Note the dimensions of ρ τ are kg 2 velocity 2 meter = 1 sec 2 We will interpret this velocity in upcoming slides. II. Generalizing the 1-dimensional wave equation First generalize the notation. i) "q" has meant transverse deflection of the string. Replace q Ψ, where Ψ may indicate other properties of the medium that

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Numerical Methods for Partial Differential Equations Finite Difference Methods

More information

Computation Fluid Dynamics

Computation Fluid Dynamics Computation Fluid Dynamics CFD I Jitesh Gajjar Maths Dept Manchester University Computation Fluid Dynamics p.1/189 Garbage In, Garbage Out We will begin with a discussion of errors. Useful to understand

More information

PEAT SEISMOLOGY Lecture 2: Continuum mechanics

PEAT SEISMOLOGY Lecture 2: Continuum mechanics PEAT8002 - SEISMOLOGY Lecture 2: Continuum mechanics Nick Rawlinson Research School of Earth Sciences Australian National University Strain Strain is the formal description of the change in shape of a

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

ICON-IAP: A non-hydrostatic global. Almut Gassmann IAP Kühlungsborn, Germany. model designed for energetic consistency

ICON-IAP: A non-hydrostatic global. Almut Gassmann IAP Kühlungsborn, Germany. model designed for energetic consistency ICON-IAP: A non-hydrostatic global Almut Gassmann IAP Kühlungsborn, Germany model designed for energetic consistency ICON-IAP is a model on a Voronoi mesh: The divergence lives on Voronoi cells (mostly

More information

3 2 6 Solve the initial value problem u ( t) 3. a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1

3 2 6 Solve the initial value problem u ( t) 3. a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1 Math Problem a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1 3 6 Solve the initial value problem u ( t) = Au( t) with u (0) =. 3 1 u 1 =, u 1 3 = b- True or false and why 1. if A is

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

PAPER 333 FLUID DYNAMICS OF CLIMATE

PAPER 333 FLUID DYNAMICS OF CLIMATE MATHEMATICAL TRIPOS Part III Wednesday, 1 June, 2016 1:30 pm to 4:30 pm Draft 21 June, 2016 PAPER 333 FLUID DYNAMICS OF CLIMATE Attempt no more than THREE questions. There are FOUR questions in total.

More information

Fast Numerical Methods for Stochastic Computations

Fast Numerical Methods for Stochastic Computations Fast AreviewbyDongbinXiu May 16 th,2013 Outline Motivation 1 Motivation 2 3 4 5 Example: Burgers Equation Let us consider the Burger s equation: u t + uu x = νu xx, x [ 1, 1] u( 1) =1 u(1) = 1 Example:

More information

Fourth Order Convergence of Compact Finite Difference Solver for 2D Incompressible Flow

Fourth Order Convergence of Compact Finite Difference Solver for 2D Incompressible Flow Fourth Order Convergence of Compact Finite Difference Solver for D Incompressible Flow Cheng Wang 1 Institute for Scientific Computing and Applied Mathematics and Department of Mathematics, Indiana University,

More information

Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS

Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS 5.1 Introduction When a physical system depends on more than one variable a general

More information

Introduction to Scientific Computing

Introduction to Scientific Computing (Lecture 5: Linear system of equations / Matrix Splitting) Bojana Rosić, Thilo Moshagen Institute of Scientific Computing Motivation Let us resolve the problem scheme by using Kirchhoff s laws: the algebraic

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

Quick Recapitulation of Fluid Mechanics

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

More information

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

Math 471 (Numerical methods) Chapter 3 (second half). System of equations

Math 471 (Numerical methods) Chapter 3 (second half). System of equations Math 47 (Numerical methods) Chapter 3 (second half). System of equations Overlap 3.5 3.8 of Bradie 3.5 LU factorization w/o pivoting. Motivation: ( ) A I Gaussian Elimination (U L ) where U is upper triangular

More information

Eddy viscosity. AdOc 4060/5060 Spring 2013 Chris Jenkins. Turbulence (video 1hr):

Eddy viscosity. AdOc 4060/5060 Spring 2013 Chris Jenkins. Turbulence (video 1hr): AdOc 4060/5060 Spring 2013 Chris Jenkins Eddy viscosity Turbulence (video 1hr): http://cosee.umaine.edu/programs/webinars/turbulence/?cfid=8452711&cftoken=36780601 Part B Surface wind stress Wind stress

More information

1. Fast Iterative Solvers of SLE

1. Fast Iterative Solvers of SLE 1. Fast Iterative Solvers of crucial drawback of solvers discussed so far: they become slower if we discretize more accurate! now: look for possible remedies relaxation: explicit application of the multigrid

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 3 Solvers of linear algebraic equations 3.1. Outline of Lecture Finite-difference method for a 2D elliptic PDE

More information

MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS NUMERICAL FLUID MECHANICS FALL 2011

MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS NUMERICAL FLUID MECHANICS FALL 2011 MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS 02139 2.29 NUMERICAL FLUID MECHANICS FALL 2011 QUIZ 2 The goals of this quiz 2 are to: (i) ask some general

More information

Symmetry and Properties of Crystals (MSE638) Stress and Strain Tensor

Symmetry and Properties of Crystals (MSE638) Stress and Strain Tensor Symmetry and Properties of Crystals (MSE638) Stress and Strain Tensor Somnath Bhowmick Materials Science and Engineering, IIT Kanpur April 6, 2018 Tensile test and Hooke s Law Upto certain strain (0.75),

More information

, 孙世玮 中国科学院大气物理研究所,LASG 2 南京大学, 大气科学学院

, 孙世玮 中国科学院大气物理研究所,LASG 2 南京大学, 大气科学学院 傅豪 1,2, 林一骅 1, 孙世玮 2, 周博闻 2, 王元 2 1 中国科学院大气物理研究所,LASG 2 南京大学, 大气科学学院 The Vortical Atmosphere & Ocean https://en.wikipedia.org/wiki/file:tropical_cyclon e_zoe_2002.jpg http://blogs.egu.eu/geolog/tag/mesoscale-eddy/

More information

Lattice Boltzmann Method for Moving Boundaries

Lattice Boltzmann Method for Moving Boundaries Lattice Boltzmann Method for Moving Boundaries Hans Groot March 18, 2009 Outline 1 Introduction 2 Moving Boundary Conditions 3 Cylinder in Transient Couette Flow 4 Collision-Advection Process for Moving

More information

Seminar 6: COUPLED HARMONIC OSCILLATORS

Seminar 6: COUPLED HARMONIC OSCILLATORS Seminar 6: COUPLED HARMONIC OSCILLATORS 1. Lagrangian Equations of Motion Let consider a system consisting of two harmonic oscillators that are coupled together. As a model, we will use two particles attached

More information

Mechanics of Earthquakes and Faulting

Mechanics of Earthquakes and Faulting Mechanics of Earthquakes and Faulting www.geosc.psu.edu/courses/geosc508 Overview Milestones in continuum mechanics Concepts of modulus and stiffness. Stress-strain relations Elasticity Surface and body

More information

Physical Metaphors for Graphs

Physical Metaphors for Graphs Graphs and Networks Lecture 3 Physical Metaphors for Graphs Daniel A. Spielman October 9, 203 3. Overview We will examine physical metaphors for graphs. We begin with a spring model and then discuss resistor

More information

NOVEL FINITE DIFFERENCE SCHEME FOR THE NUMERICAL SOLUTION OF TWO-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

NOVEL FINITE DIFFERENCE SCHEME FOR THE NUMERICAL SOLUTION OF TWO-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume 7 Number Pages 3 39 c Institute for Scientific Computing and Information NOVEL FINITE DIFFERENCE SCHEME FOR THE NUMERICAL SOLUTION OF TWO-DIMENSIONAL

More information

The JHU Turbulence Databases (JHTDB)

The JHU Turbulence Databases (JHTDB) The JHU Turbulence Databases (JHTDB) TURBULENT CHANNEL FLOW DATA SET Data provenance: J. Graham 1, M. Lee 2, N. Malaya 2, R.D. Moser 2, G. Eyink 1 & C. Meneveau 1 Database ingest and Web Services: K. Kanov

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

Explicit algebraic Reynolds stress models for boundary layer flows

Explicit algebraic Reynolds stress models for boundary layer flows 1. Explicit algebraic models Two explicit algebraic models are here compared in order to assess their predictive capabilities in the simulation of boundary layer flow cases. The studied models are both

More information

Chapter 6: The Rouse Model. The Bead (friction factor) and Spring (Gaussian entropy) Molecular Model:

Chapter 6: The Rouse Model. The Bead (friction factor) and Spring (Gaussian entropy) Molecular Model: G. R. Strobl, Chapter 6 "The Physics of Polymers, 2'nd Ed." Springer, NY, (1997). R. B. Bird, R. C. Armstrong, O. Hassager, "Dynamics of Polymeric Liquids", Vol. 2, John Wiley and Sons (1977). M. Doi,

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Discretization of Boundary Conditions Discretization of Boundary Conditions On

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

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

7 Mathematical Methods 7.6 Insulation (10 units)

7 Mathematical Methods 7.6 Insulation (10 units) 7 Mathematical Methods 7.6 Insulation (10 units) There are no prerequisites for this project. 1 Introduction When sheets of plastic and of other insulating materials are used in the construction of building

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

Appendix C: Recapitulation of Numerical schemes

Appendix C: Recapitulation of Numerical schemes Appendix C: Recapitulation of Numerical schemes August 31, 2009) SUMMARY: Certain numerical schemes of general use are regrouped here in order to facilitate implementations of simple models C1 The tridiagonal

More information

256 Summary. D n f(x j ) = f j+n f j n 2n x. j n=1. α m n = 2( 1) n (m!) 2 (m n)!(m + n)!. PPW = 2π k x 2 N + 1. i=0?d i,j. N/2} N + 1-dim.

256 Summary. D n f(x j ) = f j+n f j n 2n x. j n=1. α m n = 2( 1) n (m!) 2 (m n)!(m + n)!. PPW = 2π k x 2 N + 1. i=0?d i,j. N/2} N + 1-dim. 56 Summary High order FD Finite-order finite differences: Points per Wavelength: Number of passes: D n f(x j ) = f j+n f j n n x df xj = m α m dx n D n f j j n= α m n = ( ) n (m!) (m n)!(m + n)!. PPW =

More information

Multigrid Methods and their application in CFD

Multigrid Methods and their application in CFD Multigrid Methods and their application in CFD Michael Wurst TU München 16.06.2009 1 Multigrid Methods Definition Multigrid (MG) methods in numerical analysis are a group of algorithms for solving differential

More information