THE CONVECTION DIFFUSION EQUATION

Size: px
Start display at page:

Download "THE CONVECTION DIFFUSION EQUATION"

Transcription

1 3 THE CONVECTION DIFFUSION EQUATION We next consider the convection diffusion equation ɛ 2 u + w u = f, (3.) where ɛ>. This equation arises in numerous models of flows and other physical phenomena. The unknown function u may represent the concentration of a pollutant being transported (or convected ) along a stream moving at velocity w and also subject to diffusive effects. Alternatively, it may represent the temperature of a fluid moving along a heated wall, or the concentration of electrons in models of semiconductor devices. This equation is also a fundamental subproblem for models of incompressible flow, considered in Chapter 7, where u is a vector-valued function representing flow velocity and ɛ is a viscosity parameter. Typically, diffusion is a less significant physical effect than convection: on a windy day the smoke from a chimney moves in the direction of the wind and any spreading due to molecular diffusion is small. This implies that, for most practical problems, ɛ w. This chapter is concerned with the properties of finite element discretization of the convection diffusion equation, and Chapter 4 with effective algorithms for solving the discrete linear equation systems that arise from the discretization process. The boundary value problem that is considered is equation (3.) posed on a two-dimensional or three-dimensional domain Ω, together with boundary conditions on Ω = Ω D Ω N given by (.4), that is, u = g D on Ω D, u n = g N on Ω N. (3.2) We will assume, as is commonly the case, that the flow characterized by w is incompressible, that is, div w =. The domain boundary Ω will be subdivided according to its relation with the velocity field w: if n denotes the outwardpointing normal to the boundary, then Ω + = {x Ω w n >}, Ω = {x Ω w n =}, Ω = {x Ω w n <}, the outflow boundary, the characteristic boundary, the inflow boundary. The presence of the first-order convection term w u gives the convection diffusion equation a decidedly different character from that of the Poisson equation. Under the assumption that ɛ/( w L) is small, where L is a 3

2 4 THE CONVECTION DIFFUSION EQUATION characteristic length scale associated with (3.), the solution to (3.) in most of the domain tends to be close to the solution, û, of the hyperbolic equation w û = f. (3.3) Let us first briefly consider this alternative equation, which will be referred to as the reduced problem. The differential operator of (3.3) is of lower order than that of (3.), and û generally cannot satisfy all the boundary conditions imposed on u. To see this, consider the streamlines or characteristic curves associated with w as illustrated in Figure 3.. These are defined to be the parameterized curves c(s) that have tangent vector w( c(s)) at every point on c. The characterization d c/ds = w implies that, for a fixed streamline, the solution to the reduced problem satisfies the ordinary differential equation d [û( c(s))] = f( c(s)). (3.4) ds Equivalently, if f =, the reduced solution is constant along streamlines. Suppose further that the parameterization is such that c(s ) lies on the inflow boundary Ω for some s. If u( c(s )) is used to specify an initial condition for the differential equation (3.4), and if, in addition, for some s >s, c(s ) intersects another point on Ω (say on the outflow boundary Ω + ), then the boundary value û( c(s )) is determined by solving (3.4). This value need not have any relation to the corresponding value taken on by u, which is determined by (3.2). Notice also that in the case of a discontinuous boundary condition on Ω, the characterization (3.4) implies that û will have a discontinuity propagating into Ω along the streamline that originates at the point of discontinuity on the inflow boundary. Because of these phenomena, it often happens that the solution u to the convection diffusion equation has a steep gradient in a portion of the domain. For example, u may be close to û in most of Ω, but along a streamline going to an outflow boundary where u and û differ, u will exhibit a steep gradient in order to satisfy the boundary condition. (The following one-dimensional problem offers a lot of insight here: given ɛ and w>, find u(x) such that ɛu +wu = for x (,L), with u() =,u(l) = ; see Problem 3..) In such a situation, the problem defined by (3.) and boundary conditions (3.2) is said to be singularly perturbed, and the solution u has an exponential boundary layer. The diffusion in Fig. 3.. Streamline c(s) associated with vector field w.

3 REFERENCE PROBLEMS 5 equation (3.) may also lead to steep gradients transverse to streamlines where u is smoother than û. For example, for a discontinuous boundary condition on Ω as discussed above, the diffusion term in (3.) leads to a smoothing of the discontinuity inside Ω. In this instance the solution u is continuous but rapidly varying across an internal layer that follows the streamline emanating from the discontinuity on the inflow boundary. The presence of layers of both types makes it difficult to construct accurate discrete approximations in cases when convection is dominant. Equally significant, when w, the boundary value problem (3.) (3.2) is not self-adjoint. (This means that Ω (Lu)v u (Lv), where the differential Ω operator of (3.) is denoted by L = ɛ 2 + w. ) As a result, the coefficient matrix derived from discretization is invariably nonsymmetric in contrast to the Poisson problem where the coefficient matrix is always symmetric positivesemidefinite. Non-symmetry in turn affects the choice and performance of iterative solution algorithms for solving the discrete problems, and different techniques from those discussed in Chapter 2 must be used to achieve effective performance. In discussing convection diffusion equations, it is useful to have a quantitative measure of the relative contributions of convection and diffusion. This can be done by normalizing equation (3.) with respect to the size of the domain and the magnitude of the velocity. Thus, as above, let L denote a characterizing length scale for the domain Ω; for example, L can be the Poincaré constant of Lemma.2. In addition, let the velocity w be specified as w =W w where W is a positive constant and w is normalized to have value unity in some measure. If points in Ω are denoted by x, then ξ = x/l denotes elements of a normalized domain. With u ( ξ)=u(l ξ) on this domain, (3.) can be rewritten as ( ) WL 2 u + ɛ w u = L2 f, (3.5) ɛ and the relative contributions of convection and diffusion can be encapsulated in the Peclet number: P := WL ɛ. (3.6) If P, equation (3.5) is diffusion-dominated and relatively benign. In contrast, the construction of accurate approximations and the design of effective solvers in the convection-dominated case, (3.5) with P, will be shown to be fraught with difficulty. 3. Reference problems Here and subsequently, we will refer to the velocity vector w as the wind. Several examples of two-dimensional convection diffusion problems will be used to illustrate the effect of the wind direction and strength on properties of solutions, and on the quality of finite element discretizations. The problems are all posed

4 6 THE CONVECTION DIFFUSION EQUATION on the square domain Ω Ω =(, ) (, ), with wind of order unity w = O() and zero source term f =. Since the Peclet number is inversely proportional to ɛ the problems are convection-dominated if ɛ. The quality and accuracy of discretizations of these problems will be discussed in Sections 3.3 and 3.4, and special issues relating to solution algorithms will be considered in Chapter Example: Analytic solution, zero source term, constant vertical wind, exponential boundary layer. The function ( ) e (y )/ɛ u(x, y) =x e 2/ɛ (3.7) satisfies equation (3.) with w =(, ) and f =. Dirichlet conditions on the boundary Ω are determined by (3.7) and satisfy u(x, ) = x, u(x, ) =, u(,y), u(,y), where the latter two approximations hold except near y =. The streamlines are given by the vertical lines c(s) = (α, s) where α (, ) is constant, giving a flow in the vertical direction. On the characteristic boundaries x = ±, the boundary values vary dramatically near y =, changing from (essentially) to on the left and from + to on the right. For small ɛ, the solution u is very close to that of the reduced problem û x except near the outflow boundary y =, where it is zero. u=.5 u u u=x.5 x y Fig Contour plot (left) and three-dimensional surface plot (right) of an accurate finite element solution of Example 3.., for ɛ = /2.

5 REFERENCE PROBLEMS 7 The dramatic change in the value of u near y = constitutes a boundary layer. In this example, the layer is determined by the function e ( y)/ɛ and has width proportional to ɛ. Figure 3.2 shows a contour plot and three-dimensional rendering of the solution for ɛ =/2. Using asymptotic expansions (see Eckhaus [53]), it can be shown in general that boundary layers arising from hard Dirichlet conditions on the outflow boundary can be represented using exponential functions in local coordinates. Following Roos et al. [59, Section III..3], we refer to such layers as exponential boundary layers. For w, they have width inversely proportional to the Peclet number Example: Zero source term, variable vertical wind, characteristic boundary layers In this example the wind is vertical w = (, +(x + ) 2 /4) but increases in strength from left to right. Dirichlet boundary values apply on the inflow and characteristic boundary segments; u is set to unity on the inflow boundary, and decreases to zero quadratically on the right wall, and cubically on the left wall, see Figure 3.3. A zero Neumann condition on the top boundary ensures that there is no exponential boundary layer in this case. The fact that the reduced solution û is incompatible with the specified values on the characteristic boundary, generates characteristic layers on each side. These layers are typical of so-called shear layers that commonly arise in fluid flow models. The width of shear layers is proportional to ɛ rather than ɛ, so they are less intimidating than exponential layers this can be seen by comparing the solution in Figure 3.3 with that in Figure 3.2. The reason that the layer on the right is sharper than the layer on the left is that the wind is twice as strong along the associated boundary. u / y =.5 u= Fig Contour plot (left) and three-dimensional surface plot (right) of an accurate finite element solution of Example 3..2, for ɛ = /2.

6 8 THE CONVECTION DIFFUSION EQUATION 3..3 Example: Zero source term, constant wind at a 3 angle to the left of vertical, downstream boundary layer and interior layer. In this example, the wind is a constant vector w = ( sin π 6, cos π 6 ). Dirichlet boundary conditions are imposed everywhere on Ω, with values either zero or unity with a jump discontinuity at the point (, ) as illustrated in Figure 3.4. The inflow boundary is composed of the bottom and right portions of Ω, [x, ] [, y], and the reduced problem solution û is constant along the streamlines { (x, y) 2 y + } 3 2 x = constant, (3.8) with values determined by the inflow boundary condition. The discontinuity of the boundary condition causes û to be a discontinuous function with the value û = to the left of the streamline y + 3x = and the value û = to the right. The diffusion term present in (3.) causes this discontinuity to be smeared, producing an internal layer of width O( ɛ). There is also an exponential boundary layer near the top boundary y =, where the value of u drops rapidly from u tou =. Figure 3.4 shows contour and surface plots of the solution for ɛ =/2. An alternative characterization of streamlines may be obtained from the fact that in two dimensions, incompressibility via div w = implies that w = ( ψ y, ψ ) T, (3.9) x u=.5 u= u= u= u=.5 y x Fig Contour plot (left) and three-dimensional surface plot (right) of an accurate finite element solution of Example 3..3, for ɛ = /2.

7 REFERENCE PROBLEMS 9 where ψ(x, y) is an associated stream function. Defining the level curves of ψ as the set of points (x, y) Ω for which ψ(x, y) = constant, (3.) it can be shown that the streamlines in (3.8) are parallel to these level curves, see Problem 3.2. The upshot is that (3.) can be taken as the definition of the streamlines for two-dimensional problems. This alternative characterization can also be applied in cases when the basic definition is not applicable. It is used, for example, in the following reference problem, which does not have an inflow boundary segment so that the corresponding reduced problem (3.3) does not have a uniquely defined solution Example: Zero source term, recirculating wind, characteristic boundary layers. This example is known as the double-glazing problem: it is a simple model for the temperature distribution in a cavity with an external wall that is hot. The wind w =(2y( x 2 ), 2x( y 2 )) determines a recirculating flow with streamlines {(x, y) ( x 2 )( y 2 ) = constant}. All boundaries are of characteristic type. Dirichlet boundary conditions are imposed everywhere on Ω, and there are discontinuities at the two corners of the hot wall, x =,y = ±. These discontinuities lead to boundary layers near these corners, as shown in Figure 3.5. Although these layers are comparable in width to those in Figure 3.3, it is emphasized that their structure is not accessible via asymptotic techniques, unlike the layers in the first three examples. u=.5 u= u= u= y x Fig Contour plot (left) and three-dimensional surface plot (right) of an accurate finite element solution of Example 3..4, for ɛ = /2.

NUMERICAL STUDY OF CONVECTION DIFFUSION PROBLEM IN TWO- DIMENSIONAL SPACE

NUMERICAL STUDY OF CONVECTION DIFFUSION PROBLEM IN TWO- DIMENSIONAL SPACE IJRRAS 5 () November NUMERICAL STUDY OF CONVECTION DIFFUSION PROBLEM IN TWO- DIMENSIONAL SPACE. K. Sharath Babu,* & N. Srinivasacharyulu Research Scholar, Department of Mathematics, National Institute

More information

UNIVERSITY of LIMERICK

UNIVERSITY of LIMERICK UNIVERSITY of LIMERICK OLLSCOIL LUIMNIGH Faculty of Science and Engineering END OF SEMESTER ASSESSMENT PAPER MODULE CODE: MA4607 SEMESTER: Autumn 2012-13 MODULE TITLE: Introduction to Fluids DURATION OF

More information

The purpose of this lecture is to present a few applications of conformal mappings in problems which arise in physics and engineering.

The purpose of this lecture is to present a few applications of conformal mappings in problems which arise in physics and engineering. Lecture 16 Applications of Conformal Mapping MATH-GA 451.001 Complex Variables The purpose of this lecture is to present a few applications of conformal mappings in problems which arise in physics and

More information

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Roy Stogner Computational Fluid Dynamics Lab Institute for Computational Engineering and Sciences University of Texas at Austin March

More information

Recovery-Based A Posteriori Error Estimation

Recovery-Based A Posteriori Error Estimation Recovery-Based A Posteriori Error Estimation Zhiqiang Cai Purdue University Department of Mathematics, Purdue University Slide 1, March 2, 2011 Outline Introduction Diffusion Problems Higher Order Elements

More information

Fluid Mechanics. Chapter 9 Surface Resistance. Dr. Amer Khalil Ababneh

Fluid Mechanics. Chapter 9 Surface Resistance. Dr. Amer Khalil Ababneh Fluid Mechanics Chapter 9 Surface Resistance Dr. Amer Khalil Ababneh Wind tunnel used for testing flow over models. Introduction Resistances exerted by surfaces are a result of viscous stresses which create

More information

u xx + u yy = 0. (5.1)

u xx + u yy = 0. (5.1) Chapter 5 Laplace Equation The following equation is called Laplace equation in two independent variables x, y: The non-homogeneous problem u xx + u yy =. (5.1) u xx + u yy = F, (5.) where F is a function

More information

Lecture Introduction

Lecture Introduction Lecture 1 1.1 Introduction The theory of Partial Differential Equations (PDEs) is central to mathematics, both pure and applied. The main difference between the theory of PDEs and the theory of Ordinary

More information

Introduction. J.M. Burgers Center Graduate Course CFD I January Least-Squares Spectral Element Methods

Introduction. J.M. Burgers Center Graduate Course CFD I January Least-Squares Spectral Element Methods Introduction In this workshop we will introduce you to the least-squares spectral element method. As you can see from the lecture notes, this method is a combination of the weak formulation derived from

More information

Due Tuesday, November 23 nd, 12:00 midnight

Due Tuesday, November 23 nd, 12:00 midnight Due Tuesday, November 23 nd, 12:00 midnight This challenging but very rewarding homework is considering the finite element analysis of advection-diffusion and incompressible fluid flow problems. Problem

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

Problem 4.3. Problem 4.4

Problem 4.3. Problem 4.4 Problem 4.3 Problem 4.4 Problem 4.5 Problem 4.6 Problem 4.7 This is forced convection flow over a streamlined body. Viscous (velocity) boundary layer approximations can be made if the Reynolds number Re

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 Introduction to Hyperbolic Equations The Hyperbolic Equations n-d 1st Order Linear

More information

A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations

A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations Hao Li Math Dept, Purdue Univeristy Ocean University of China, December, 2017 Joint work with

More information

Week 2 Notes, Math 865, Tanveer

Week 2 Notes, Math 865, Tanveer Week 2 Notes, Math 865, Tanveer 1. Incompressible constant density equations in different forms Recall we derived the Navier-Stokes equation for incompressible constant density, i.e. homogeneous flows:

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

Simple Examples on Rectangular Domains

Simple Examples on Rectangular Domains 84 Chapter 5 Simple Examples on Rectangular Domains In this chapter we consider simple elliptic boundary value problems in rectangular domains in R 2 or R 3 ; our prototype example is the Poisson equation

More information

Separation of Variables in Linear PDE: One-Dimensional Problems

Separation of Variables in Linear PDE: One-Dimensional Problems Separation of Variables in Linear PDE: One-Dimensional Problems Now we apply the theory of Hilbert spaces to linear differential equations with partial derivatives (PDE). We start with a particular example,

More information

NONLOCAL DIFFUSION EQUATIONS

NONLOCAL DIFFUSION EQUATIONS NONLOCAL DIFFUSION EQUATIONS JULIO D. ROSSI (ALICANTE, SPAIN AND BUENOS AIRES, ARGENTINA) jrossi@dm.uba.ar http://mate.dm.uba.ar/ jrossi 2011 Non-local diffusion. The function J. Let J : R N R, nonnegative,

More information

The Dirichlet boundary problems for second order parabolic operators satisfying a Carleson condition

The Dirichlet boundary problems for second order parabolic operators satisfying a Carleson condition The Dirichlet boundary problems for second order parabolic operators satisfying a Martin Dindos Sukjung Hwang University of Edinburgh Satellite Conference in Harmonic Analysis Chosun University, Gwangju,

More information

A High-Order Discontinuous Galerkin Method for the Unsteady Incompressible Navier-Stokes Equations

A High-Order Discontinuous Galerkin Method for the Unsteady Incompressible Navier-Stokes Equations A High-Order Discontinuous Galerkin Method for the Unsteady Incompressible Navier-Stokes Equations Khosro Shahbazi 1, Paul F. Fischer 2 and C. Ross Ethier 1 1 University of Toronto and 2 Argonne National

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

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

Various lecture notes for

Various lecture notes for Various lecture notes for 18306. R. R. Rosales (MIT, Math. Dept., 2-337) April 14, 2014 Abstract Notes for MIT s 18.306 Advanced PDE with applications. Contents 1 First lecture. 3 Tomography. Use filtering

More information

Open boundary conditions in numerical simulations of unsteady incompressible flow

Open boundary conditions in numerical simulations of unsteady incompressible flow Open boundary conditions in numerical simulations of unsteady incompressible flow M. P. Kirkpatrick S. W. Armfield Abstract In numerical simulations of unsteady incompressible flow, mass conservation can

More information

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

7 EQUATIONS OF MOTION FOR AN INVISCID FLUID

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

More information

Optimization and control of a separated boundary-layer flow

Optimization and control of a separated boundary-layer flow Optimization and control of a separated boundary-layer flow Journal: 2011 Hawaii Summer Conferences Manuscript ID: Draft lumeetingid: 2225 Date Submitted by the Author: n/a Contact Author: PASSAGGIA, Pierre-Yves

More information

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations Moshe Israeli Computer Science Department, Technion-Israel Institute of Technology, Technion city, Haifa 32000, ISRAEL Alexander

More information

1. Introduction. Consider the Navier Stokes equations ηu t ν 2 u + (u grad) u + grad p = f div u = 0 (1.1)

1. Introduction. Consider the Navier Stokes equations ηu t ν 2 u + (u grad) u + grad p = f div u = 0 (1.1) University of Maryland Department of Computer Science TR-C4930 University of Maryland Institute for Advanced Computer Studies TR-009-0 BOUNDARY CONDITIONS IN APPROXIMATE COMMUTATOR PRECONDITIONERS FOR

More information

Résonance et contrôle en cavité ouverte

Résonance et contrôle en cavité ouverte Résonance et contrôle en cavité ouverte Jérôme Hœpffner KTH, Sweden Avec Espen Åkervik, Uwe Ehrenstein, Dan Henningson Outline The flow case Investigation tools resonance Reduced dynamic model for feedback

More information

UNIT IV BOUNDARY LAYER AND FLOW THROUGH PIPES Definition of boundary layer Thickness and classification Displacement and momentum thickness Development of laminar and turbulent flows in circular pipes

More information

Thin airfoil theory. Chapter Compressible potential flow The full potential equation

Thin airfoil theory. Chapter Compressible potential flow The full potential equation hapter 4 Thin airfoil theory 4. ompressible potential flow 4.. The full potential equation In compressible flow, both the lift and drag of a thin airfoil can be determined to a reasonable level of accuracy

More information

INTRODUCTION TO PDEs

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

More information

Kinematics of fluid motion

Kinematics of fluid motion Chapter 4 Kinematics of fluid motion 4.1 Elementary flow patterns Recall the discussion of flow patterns in Chapter 1. The equations for particle paths in a three-dimensional, steady fluid flow are dx

More information

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

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

More information

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

i.e. the conservation of mass, the conservation of linear momentum, the conservation of energy.

i.e. the conservation of mass, the conservation of linear momentum, the conservation of energy. 04/04/2017 LECTURE 33 Geometric Interpretation of Stream Function: In the last class, you came to know about the different types of boundary conditions that needs to be applied to solve the governing equations

More information

Lucio Demeio Dipartimento di Ingegneria Industriale e delle Scienze Matematiche

Lucio Demeio Dipartimento di Ingegneria Industriale e delle Scienze Matematiche Scuola di Dottorato THE WAVE EQUATION Lucio Demeio Dipartimento di Ingegneria Industriale e delle Scienze Matematiche Lucio Demeio - DIISM wave equation 1 / 44 1 The Vibrating String Equation 2 Second

More information

Department of Mechanical Engineering

Department of Mechanical Engineering Department of Mechanical Engineering AMEE401 / AUTO400 Aerodynamics Instructor: Marios M. Fyrillas Email: eng.fm@fit.ac.cy HOMEWORK ASSIGNMENT #2 QUESTION 1 Clearly there are two mechanisms responsible

More information

Project #1 Internal flow with thermal convection

Project #1 Internal flow with thermal convection Project #1 Internal flow with thermal convection MAE 494/598, Fall 2017, Project 1 (20 points) Hard copy of report is due at the start of class on the due date. The rules on collaboration will be released

More information

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES)

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) RAYTCHO LAZAROV 1 Notations and Basic Functional Spaces Scalar function in R d, d 1 will be denoted by u,

More information

Mush liquid interfaces with cross flow

Mush liquid interfaces with cross flow Mush liquid interfaces with cross flow Devin Conroy March 15, 27 1 Introduction The solidification of a binary melt growing into a supercooled region may lead to the formation of a mushy layer as a result

More information

A CHARACTERISATION OF OSCILLATIONS IN THE DISCRETE TWO-DIMENSIONAL CONVECTION-DIFFUSION EQUATION

A CHARACTERISATION OF OSCILLATIONS IN THE DISCRETE TWO-DIMENSIONAL CONVECTION-DIFFUSION EQUATION MATHEMATICS OF COMPUTATIO Volume 7, umber 4, Pages 63 88 S 5-578()39-8 Article electronically published on December 4, A CHARACTERISATIO OF OSCILLATIOS I THE DISCRETE TWO-DIMESIOAL COVECTIO-DIFFUSIO EQUATIO

More information

Fluid flow II: The stream function

Fluid flow II: The stream function 5//0 Miscellaneous Exercises Fluid Flow II Fluid flow II: The stream function This exercise is a continuation of the Fluid flow I exercise. Read that exercise an introduction. It is possible to obtain

More information

Finite Difference Methods for 3D Viscous Incompressible Flows in the Vorticity Vector Potential Formulation on Nonstaggered Grids

Finite Difference Methods for 3D Viscous Incompressible Flows in the Vorticity Vector Potential Formulation on Nonstaggered Grids JOURNAL OF COMPUTATIONAL PHYSICS 138, 57 82 (1997) ARTICLE NO. CP975815 Finite Difference Methods for 3D Viscous Incompressible Flows in the Vorticity Vector Potential Formulation on Nonstaggered Grids

More information

7 Hyperbolic Differential Equations

7 Hyperbolic Differential Equations Numerical Analysis of Differential Equations 243 7 Hyperbolic Differential Equations While parabolic equations model diffusion processes, hyperbolic equations model wave propagation and transport phenomena.

More information

Discontinuous Galerkin methods for nonlinear elasticity

Discontinuous Galerkin methods for nonlinear elasticity Discontinuous Galerkin methods for nonlinear elasticity Preprint submitted to lsevier Science 8 January 2008 The goal of this paper is to introduce Discontinuous Galerkin (DG) methods for nonlinear elasticity

More information

MATH 220: MIDTERM OCTOBER 29, 2015

MATH 220: MIDTERM OCTOBER 29, 2015 MATH 22: MIDTERM OCTOBER 29, 25 This is a closed book, closed notes, no electronic devices exam. There are 5 problems. Solve Problems -3 and one of Problems 4 and 5. Write your solutions to problems and

More information

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends Lecture 3: Finite Elements in 2-D Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Finite Element Methods 1 / 18 Outline 1 Boundary

More information

Spatial discretization scheme for incompressible viscous flows

Spatial discretization scheme for incompressible viscous flows Spatial discretization scheme for incompressible viscous flows N. Kumar Supervisors: J.H.M. ten Thije Boonkkamp and B. Koren CASA-day 2015 1/29 Challenges in CFD Accuracy a primary concern with all CFD

More information

SUPG STABILIZATION PARAMETERS CALCULATED FROM THE QUADRATURE-POINT COMPONENTS OF THE ELEMENT-LEVEL MATRICES

SUPG STABILIZATION PARAMETERS CALCULATED FROM THE QUADRATURE-POINT COMPONENTS OF THE ELEMENT-LEVEL MATRICES European Congress on Computational Methods in Applied Sciences and Engineering ECCOMAS 24 P. Neittaanmäki, T. Rossi, K. Majava, and O. Pironneau (eds.) W. Rodi and P. Le Quéré (assoc. eds.) Jyväskylä,

More information

Solving PDEs with freefem++

Solving PDEs with freefem++ Solving PDEs with freefem++ Tutorials at Basque Center BCA Olivier Pironneau 1 with Frederic Hecht, LJLL-University of Paris VI 1 March 13, 2011 Do not forget That everything about freefem++ is at www.freefem.org

More information

Chapter 5. Shallow Water Equations. 5.1 Derivation of shallow water equations

Chapter 5. Shallow Water Equations. 5.1 Derivation of shallow water equations Chapter 5 Shallow Water Equations So far we have concentrated on the dynamics of small-scale disturbances in the atmosphere and ocean with relatively simple background flows. In these analyses we have

More information

MULTISCALE NUMERICAL METHODS FOR SINGULARLY PERTURBED CONVECTION-DIFFUSION EQUATIONS

MULTISCALE NUMERICAL METHODS FOR SINGULARLY PERTURBED CONVECTION-DIFFUSION EQUATIONS International Journal of Computational Methods Vol. 1, No. 1 (2004) 17 65 c World Scientific Publishing Company MULTISCALE NUMERICAL METHODS FOR SINGULARLY PERTURBED CONVECTION-DIFFUSION EQUATIONS PETER

More information

Key words. Convection-Diffusion, Domain Decomposition, Preconditioning, Spectral Element Method

Key words. Convection-Diffusion, Domain Decomposition, Preconditioning, Spectral Element Method University of Maryland Department of Computer Science TR-C4931 University of Maryland Institute for Advanced Computer Studies TR-2009-03 FAST ITERATIVE SOLVER FOR CONVECTION-DIFFUSION SYSTEMS WITH SPECTRAL

More information

SPLINE COLLOCATION METHOD FOR SINGULAR PERTURBATION PROBLEM. Mirjana Stojanović University of Novi Sad, Yugoslavia

SPLINE COLLOCATION METHOD FOR SINGULAR PERTURBATION PROBLEM. Mirjana Stojanović University of Novi Sad, Yugoslavia GLASNIK MATEMATIČKI Vol. 37(57(2002, 393 403 SPLINE COLLOCATION METHOD FOR SINGULAR PERTURBATION PROBLEM Mirjana Stojanović University of Novi Sad, Yugoslavia Abstract. We introduce piecewise interpolating

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

IV. Transport Phenomena Lecture 18: Forced Convection in Fuel Cells II

IV. Transport Phenomena Lecture 18: Forced Convection in Fuel Cells II IV. Transport Phenomena Lecture 18: Forced Convection in Fuel Cells II MIT Student (and MZB) As discussed in the previous lecture, we are interested in forcing fluid to flow in a fuel cell in order to

More information

Initial and Boundary Conditions

Initial and Boundary Conditions Initial and Boundary Conditions Initial- and boundary conditions are needed For a steady problems correct initial conditions is important to reduce computational time and reach convergence Boundary conditions

More information

LECTURE NOTES - III. Prof. Dr. Atıl BULU

LECTURE NOTES - III. Prof. Dr. Atıl BULU LECTURE NOTES - III «FLUID MECHANICS» Istanbul Technical University College of Civil Engineering Civil Engineering Department Hydraulics Division CHAPTER KINEMATICS OF FLUIDS.. FLUID IN MOTION Fluid motion

More information

Calculation of the separation streamlines of barchans and transverse dunes

Calculation of the separation streamlines of barchans and transverse dunes Calculation of the separation streamlines of barchans and transverse dunes H. J. Herrmann a,b, J. S. Andrade Jr. b, V. Schatz a, G. Sauermann a and E. J. R. Parteli a a ICP, University of Stuttgart, Pfaffenwaldring

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

13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs)

13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs) 13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs) A prototypical problem we will discuss in detail is the 1D diffusion equation u t = Du xx < x < l, t > finite-length rod u(x,

More information

SIMULATION OF THREE-DIMENSIONAL INCOMPRESSIBLE CAVITY FLOWS

SIMULATION OF THREE-DIMENSIONAL INCOMPRESSIBLE CAVITY FLOWS ICAS 2000 CONGRESS SIMULATION OF THREE-DIMENSIONAL INCOMPRESSIBLE CAVITY FLOWS H Yao, R K Cooper, and S Raghunathan School of Aeronautical Engineering The Queen s University of Belfast, Belfast BT7 1NN,

More information

FALLING FILM FLOW ALONG VERTICAL PLATE WITH TEMPERATURE DEPENDENT PROPERTIES

FALLING FILM FLOW ALONG VERTICAL PLATE WITH TEMPERATURE DEPENDENT PROPERTIES Proceedings of the International Conference on Mechanical Engineering 2 (ICME2) 8-2 December 2, Dhaka, Bangladesh ICME-TH-6 FALLING FILM FLOW ALONG VERTICAL PLATE WITH TEMPERATURE DEPENDENT PROPERTIES

More information

STRUCTURAL OPTIMIZATION BY THE LEVEL SET METHOD

STRUCTURAL OPTIMIZATION BY THE LEVEL SET METHOD Shape optimization 1 G. Allaire STRUCTURAL OPTIMIZATION BY THE LEVEL SET METHOD G. ALLAIRE CMAP, Ecole Polytechnique with F. JOUVE and A.-M. TOADER 1. Introduction 2. Setting of the problem 3. Shape differentiation

More information

A proof for the full Fourier series on [ π, π] is given here.

A proof for the full Fourier series on [ π, π] is given here. niform convergence of Fourier series A smooth function on an interval [a, b] may be represented by a full, sine, or cosine Fourier series, and pointwise convergence can be achieved, except possibly at

More information

CONSTRAINED PERCOLATION ON Z 2

CONSTRAINED PERCOLATION ON Z 2 CONSTRAINED PERCOLATION ON Z 2 ZHONGYANG LI Abstract. We study a constrained percolation process on Z 2, and prove the almost sure nonexistence of infinite clusters and contours for a large class of probability

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

Vortex stretching in incompressible and compressible fluids

Vortex stretching in incompressible and compressible fluids Vortex stretching in incompressible and compressible fluids Esteban G. Tabak, Fluid Dynamics II, Spring 00 1 Introduction The primitive form of the incompressible Euler equations is given by ( ) du P =

More information

p + µ 2 u =0= σ (1) and

p + µ 2 u =0= σ (1) and Master SdI mention M2FA, Fluid Mechanics program Hydrodynamics. P.-Y. Lagrée and S. Zaleski. Test December 4, 2009 All documentation is authorized except for reference [1]. Internet access is not allowed.

More information

Solution for Problem Set 19-20

Solution for Problem Set 19-20 Solution for Problem Set 19-0 compiled by Dan Grin and Nate Bode) April 16, 009 A 19.4 Ion Acoustic Waves [by Xinkai Wu 00] a) The derivation of these equations is trivial, so we omit it here. b) Write

More information

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

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

More information

A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators

A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators Jeff Ovall University of Kentucky Mathematics www.math.uky.edu/ jovall jovall@ms.uky.edu Kentucky Applied and

More information

Local discontinuous Galerkin methods for elliptic problems

Local discontinuous Galerkin methods for elliptic problems COMMUNICATIONS IN NUMERICAL METHODS IN ENGINEERING Commun. Numer. Meth. Engng 2002; 18:69 75 [Version: 2000/03/22 v1.0] Local discontinuous Galerkin methods for elliptic problems P. Castillo 1 B. Cockburn

More information

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics Diffusion / Parabolic Equations Summary of PDEs (so far...) Hyperbolic Think: advection Real, finite speed(s) at which information propagates carries changes in the solution Second-order explicit methods

More information

Chapter 3 Burgers Equation

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

More information

Poisson Solvers. William McLean. April 21, Return to Math3301/Math5315 Common Material.

Poisson Solvers. William McLean. April 21, Return to Math3301/Math5315 Common Material. Poisson Solvers William McLean April 21, 2004 Return to Math3301/Math5315 Common Material 1 Introduction Many problems in applied mathematics lead to a partial differential equation of the form a 2 u +

More information

Principles of Convection

Principles of Convection Principles of Convection Point Conduction & convection are similar both require the presence of a material medium. But convection requires the presence of fluid motion. Heat transfer through the: Solid

More information

Superconvergence of discontinuous Galerkin methods for 1-D linear hyperbolic equations with degenerate variable coefficients

Superconvergence of discontinuous Galerkin methods for 1-D linear hyperbolic equations with degenerate variable coefficients Superconvergence of discontinuous Galerkin methods for -D linear hyperbolic equations with degenerate variable coefficients Waixiang Cao Chi-Wang Shu Zhimin Zhang Abstract In this paper, we study the superconvergence

More information

Finite difference method for elliptic problems: I

Finite difference method for elliptic problems: I Finite difference method for elliptic problems: I Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in/~praveen

More information

Introduction to Partial Differential Equations

Introduction to Partial Differential Equations Introduction to Partial Differential Equations Partial differential equations arise in a number of physical problems, such as fluid flow, heat transfer, solid mechanics and biological processes. These

More information

Aerothermodynamics of high speed flows

Aerothermodynamics of high speed flows Aerothermodynamics of high speed flows AERO 0033 1 Lecture 6: D potential flow, method of characteristics Thierry Magin, Greg Dimitriadis, and Johan Boutet Thierry.Magin@vki.ac.be Aeronautics and Aerospace

More information

TPLV102 - Transport of heat by convection in a parallelepiped

TPLV102 - Transport of heat by convection in a parallelepiped Titre : TPLV102 - Transport de chaleur par convection dans[...] Date : 03/02/2011 Page : 1/6 TPLV102 - Transport of heat by convection in a parallelepiped Summary: This functionality was developed in the

More information

Travelling waves. Chapter 8. 1 Introduction

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

More information

CHAPTER 5 KINEMATICS OF FLUID MOTION

CHAPTER 5 KINEMATICS OF FLUID MOTION CHAPTER 5 KINEMATICS OF FLUID MOTION 5. ELEMENTARY FLOW PATTERNS Recall the discussion of flow patterns in Chapter. The equations for particle paths in a three-dimensional, steady fluid flow are dx -----

More information

Euler Equations: local existence

Euler Equations: local existence Euler Equations: local existence Mat 529, Lesson 2. 1 Active scalars formulation We start with a lemma. Lemma 1. Assume that w is a magnetization variable, i.e. t w + u w + ( u) w = 0. If u = Pw then u

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

Math 124A October 11, 2011

Math 124A October 11, 2011 Math 14A October 11, 11 Viktor Grigoryan 6 Wave equation: solution In this lecture we will solve the wave equation on the entire real line x R. This corresponds to a string of infinite length. Although

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

Lecture 3 (Limits and Derivatives)

Lecture 3 (Limits and Derivatives) Lecture 3 (Limits and Derivatives) Continuity In the previous lecture we saw that very often the limit of a function as is just. When this is the case we say that is continuous at a. Definition: A function

More information

An Equal-order DG Method for the Incompressible Navier-Stokes Equations

An Equal-order DG Method for the Incompressible Navier-Stokes Equations An Equal-order DG Method for the Incompressible Navier-Stokes Equations Bernardo Cockburn Guido anschat Dominik Schötzau Journal of Scientific Computing, vol. 40, pp. 188 10, 009 Abstract We introduce

More information

The CG1-DG2 method for conservation laws

The CG1-DG2 method for conservation laws for conservation laws Melanie Bittl 1, Dmitri Kuzmin 1, Roland Becker 2 MoST 2014, Germany 1 Dortmund University of Technology, Germany, 2 University of Pau, France CG1-DG2 Method - Motivation hp-adaptivity

More information

A finite difference Poisson solver for irregular geometries

A finite difference Poisson solver for irregular geometries ANZIAM J. 45 (E) ppc713 C728, 2004 C713 A finite difference Poisson solver for irregular geometries Z. Jomaa C. Macaskill (Received 8 August 2003, revised 21 January 2004) Abstract The motivation for this

More information

Table 17 1 Some general field equation terms. Heat Power. Current Source. 0 0 Boundary Current Porous Media Flow. Flow Source

Table 17 1 Some general field equation terms. Heat Power. Current Source. 0 0 Boundary Current Porous Media Flow. Flow Source 17 Related Analogies 17.1 Basic Concepts The differential equation used in a finite element study in one discipline often appears in a different discipline, but with a different physical meaning for the

More information

Boundary conditions. Diffusion 2: Boundary conditions, long time behavior

Boundary conditions. Diffusion 2: Boundary conditions, long time behavior Boundary conditions In a domain Ω one has to add boundary conditions to the heat (or diffusion) equation: 1. u(x, t) = φ for x Ω. Temperature given at the boundary. Also density given at the boundary.

More information

A GENERALIZED CONVECTION-DIFFUSION MODEL FOR SUBGRID TRANSPORT IN POROUS MEDIA

A GENERALIZED CONVECTION-DIFFUSION MODEL FOR SUBGRID TRANSPORT IN POROUS MEDIA MULTISCALE MODEL. SIMUL. Vol. 1, No. 3, pp. 504 526 c 2003 Society for Industrial and Applied Mathematics A GENERALIZED CONVECTION-DIFFUSION MODEL FOR SUBGRID TRANSPORT IN POROUS MEDIA Y. EFENDIEV AND

More information

Internal boundary layers in the ocean circulation

Internal boundary layers in the ocean circulation Internal boundary layers in the ocean circulation Lecture 9 by Andrew Wells We have so far considered boundary layers adjacent to physical boundaries. However, it is also possible to find boundary layers

More information

Discontinuous Galerkin Methods

Discontinuous Galerkin Methods Discontinuous Galerkin Methods Joachim Schöberl May 20, 206 Discontinuous Galerkin (DG) methods approximate the solution with piecewise functions (polynomials), which are discontinuous across element interfaces.

More information