Computational Fluid Dynamics

Size: px
Start display at page:

Download "Computational Fluid Dynamics"

Transcription

1 Computational Fluid Dynamics Dr.Eng. Reima Iwatsu Phone: NACO Building Room Time Summer Term Lecture: Tuesday 7:30-9:00 (every two weeks) LG4/310 Exercise: Tuesday 7:30-9:00 (every four weeks)lg4/310 Evaluation: 10% Attendance 90% Exercise and Report 90% Speeking time Tuesday 9:00-10:30 Lehrstuhl Aerodynamik und Strömungslehre (LAS) Fakultät 3, Maschinenbau, Elektrotechnik und Wirtschaftsingenieurwesen Brandenburgische Technische Universität Cottbus Karl Liebknecht-Straße 102,D Cottbus

2 Terminplanung für die Vorlesung Computational Fluid Dynamics (Di., 7:30 9:00 Uhr, LG 4 Raum 310) Date Contents of the lecture Introduction The mathematical nature of the flow equations Finite Difference Method (FDM) Finite Element Method (FEM) Finite Volume Method (FVM), Fourier/Spectral method Exercise Time integration, Stability analysis Iterative methods for algebraic systems Convection-diffusion equation Exercise Incompressible Navier Stokes(NS) equations Some remarks on incompressible fows Heat and fluid flow Turbulence model Grid generation Exercise Example CFD results Lecture from Dr.Ristau

3 Contents of the lecture Mathematical Property of the PDEs 1 Introduction 2 The Mathematical Nature of the Flow Equations Various Discretization Method 3 Finite Difference Method (FDM) 4 Finite Element Method (FEM) 5 Finite Volume Method (FVM) 6 Fourier/Spectral Method Numerical Method for Time Marching and System of Equations 7 Time Integration 8 Stability Analysis 9 Iterative Methods for Algebraic Systems 10 Convection-Diffusion Equation Incompressible Flows 11 Incompressible Navier Stokes(NS) Equations 12 Some Remarks on Incompressible Fows 13 Heat and Fluid Flow 14 Turbulence Model Grid Generation / CFD Examples 15 Grid Generation 16 Example CFD Results 17 Lecture on Applicational Computation (Dr. Ristau)

4 Contents of the lecture for today 1 Introduction 1.1 Introductnion Motivation Computational Fluid Dynamics: What is it? The Role of CFD in Modern Fluid Dynamics The Objective of This Course 1.2 The Basic Equations of Fluid Dynamics Fluid and Flow Mathematical Model Conservation Law The Continuity Equation The Momentum Equation: Navier-Stokes Equations The Energy Equation Thermodynamic Considerations Submodel 2 The Mathematical Nature of the Flow Equatnions 2.1 Linear Partical Differential Equations(PDEs) Classification of the Second Order Linear PDEs General Behaviour of the Different Classes of PDEs 2.2 The Dynamic Levels of Approximation Inviscid Flow Model: Euler Equations Parabolized Navier-Stokes Equations, Boundary Layer Approximation Potential Flow Model, Incompressible Fluid Flow Model

5 1.1 Introduction Motivation: Why should you be motivated to learn CFD? The flowfield over a supersonic blunt-nosed body Artist's conception of next generation supersonic aircraft

6 Vehicle aerodynamics, combustion and DNS of turbulence

7 Some More Examples

8 Computational Fluid Dynamics Computational Fluid Dynamics (CFD) is a discipline that solves a set of equations governing the fluid flow over any geometrical configuration. The equations can represent steady or unsteady, compressible or incompressible, and inviscid or viscous flows, including nonideal and reacting fluid behavior. The particular form chosen depends on the intended application. The state of the art is characterized by the complexity of the geometry, the flow physics, and the computer time required to obtain a solution. Fluid Mechanics and Acoustics Division NASA Langley Research Center in Hampton, VA.

9 Computational Fluid Dynamics: What is it? The physical aspects of any fluid flow are governed by the following fundamental principles: (a) mass is conserved (b) F = ma (Newton s second law) (c) energy is conserved. These fundamental principles are expressed in terms of mathematical equations (partial differential equations). CFD is the art of replacing the governing equations of fluid flow with numbers, and advancing these numbers in space and/or time to obtain a final numerical description of the complete flow field of interest. The high-speed digital computer has allowed the practical growth of CFD.

10 The Role of CFD in Modern Fluid Dynamics Pure experiment Pure theory Computational Fluid dynamics Fig. The three dimensions of fluid dynamics A new third approach. Equal partner, but never replace either.

11 The Objective of This Course To whom: The completely uninitiated student To provide what: (a) an understanding of the governing equations (b) some insight into the philosophy of CFD (c) a familiarity with various popular solution techniques; (d) a working vocabulary in the discipline At the conclusion of this course: will be well prepared to understand the literature in this field, to follow more advanced lecture series, and to begin the application of CFD to your special areas of concern. I hope...

12 1.2 The Basic Equations of Fluid Dynamics Fluid and Flow Gas, air, fuel, oxigen, CO 2 Fluid: Liquid water, oil, liquid metal that flows (Solid) (geophysical flows)

13 Eulerian description of the flow Eulerian and Lagrangian framework the velocity of the fluid u at the position x at time t u (x, t ) u (x, t ) Lagrangian labels the state and motion of the point particles a = (a 1,a 2,a 3 ) Lagrangian labels u (x, t ) = u ( X (a, t ), t ) = U (a, t ) b a U (a, 0 ) U (a, t )

14 Finite Control Volume Mathematical Model A closed volume in a finite region of the flow: a controle volume V; a controle surface S, closed surface which bounds the volume Control surface S S Control volume V V fixd in space moving with the fluid Infinitesimal Fluid Element An infinitesimally small fluid element with a volume dv volume dv

15 The Material Derivative The velocity of a point particle = the rate of change of its position X substantial, material, or convective derivative and is denoted by D/Dt The Lagrangian set (a, t ) and the Eulerian set (x, t ) The relationship between the partial derivatives of a function f The chain rule (material derivative) (temporal & spatial derivatives with respect to the Eulerian variables)

16 Control Volume Fixed in Space The Continuity Equation Physical principle: Mass is conserved. (Integral form) Gauss Divergence Theorem

17 The Continuity Equation (continued) Control Volume Moving with the Fluid The relationship between the divergence of Vand dv

18 The Continuity Equation (summary) The meaning of divergence V

19 The Momentum equation Physical principle: F = m a (Newton s second law) Navier Stokes Equations

20 The Momentum equation

21 The Energy Equation Physical principle: Conservation of energy E: total energy (= e + V 2 /2 ), e: internal energy

22 Thermodynamic Considerations Unknown flow-field variables: /rho, p, u, v, w, E( or e) Closure conditions for state variables ( e: specific internal energy, s: entropy, p: pressure, /rho: density, T: temperature) Equation of State Ideal Gas (a perfect gas) pv = nr T ( p = rho R T ) (1) V: volume, n:number of kilomoles, R=8.134 KJ: Universal Gas Constant, T: temperature [K]. pv = RT, R = R / w( p = rho RT ) (1#) v : specific volume (=V/m, V: Volume, m: mass. v=1/ rho ) w: relative molecular mass, m = n w, R: Specific Gas Constant. a thermodynamic relation e = e(t,p) (2) a perfect gas e = c v T (2#) c v : spesific heat at constant volume

23 2 The Mathematical Nature of the Flow Equatnions 2.1 Linear Partial Differential Equations (PDEs) Second Order Linear PDEs Navier Stokes Equations Second Order PDEs

24 2.1.1 Classification of the Second Order Linear PDEs F(x,y) af xx + bf xy + cf yy +df x + ef y + g = 0 b 2 4ac > 0 b 2 4ac = 0 b 2 4ac < 0 hyperbolic parabolic elliptic

25 2.1.2 General Behaviour of the Different Classes of PDEs Hyperbolic Equations Characteristic curves Region II Domain of influence y Left-running characteristic Initial data upon which p depends a P Region I Influenced by point p -Region of influence- b c Right-running characteristic Region influenced by point c x

26 Hyperbolic Equations (x,y,z) y Characteristic surface Initial data in the yz plane upon which p depends Volume which influences point p P Volume influenced by point p x z

27 Parabolic Equations Only one characteristic direction, Marching-type solutions Initial data line y c a Boundary conditions known d P Region influenced by P Boundary conditions known b x y y x=0 x=t

28 No limited regions of influence; Elliptic Equations information is propagated everywhere in all directions (at once). y b c P Boundary conditions a b x A specification of the dependent variables along the boundary. Dirichlet condition A specification of derivatives of the dependent variables along the boundary. Neumann condition A mix of both Dirichlet and Neumann conditions.

29 2.2 The Dynamic Levels of Approximation Inviscid Flow Model: Euler Equations Steady inviscid supersonic flows Wave equation

30 2.2.2 Parabolized Navier-Stokes Equations, Boundary Layer Approximation Unsteady thermal conduction Boundary-layer flows Parabolized viscous flows

31 2.2.3 Potential Flow Model, Incompressible Fluid Flow Model Physical picture consistent with the behavior of elliptic equations Potential Flow: Steady, subsonic, inviscid flow Incompressible Fluid Flow: the Mach number M = V/c 0 Flow over an airfoil Flow over a cylinder cylinder

32 Discretization techniques route map PDFs System of allgebraic equations Finite Difference Method (FDM) Finite Element Method (FEM) Finite Volume Method (FVM) Fourier / Spectral Method Basic derivations Discretization errors Time integration Initial value problem Types of solutions: Explicit and implicit Stability analysis Iterative methods Boundary value problem I.V.&B.V. problem

33 2 Finite Difference Method 2.1 Basic Concept > to discretize the geometric domain > to define a grid > a set of indices (i,j) in 2D, (i,j,k) in 3D > grid node values

34 The definition of a derivative

35 2.2 Approximation of the first derivative Taylor series expansion Expansion at x i+1 Expansion at x i-1 Using eq. at both x i+1 and x i-1

36 Truncation error

37 The Forward (FDS), backward (BDS) and central difference (CDS) Approximations truncating the series Truncation errors >for small spacing the leading term is the dominant one >The order of approximation m, m-th order accuracy Second order approximation

38 2.2.2 Polynomial fitting To fit the function an interpolation curve and differentiate it; Piecewise linear interpolation: FDS, BDS A parabola: A cubic polynomial and a polynomial of degree four: Third order BDS, third order FDS and fourth order CDS

39 2.3 Approximation of the second derivative Approximation from x i+1, x i

40 second derivative

41 2.4 Approximation of mixed derivatives non-orthogonal coordinate system combining the 1D approximations The order of differentiation can be changed

42 2.5 Implementation of boundary conditions

43 2.6 Discretization errors Truncation error (the imbalance due to the truncation of Taylor series) The exact solution of L h Discretization error Relationship between the truncation error and the discretization error Richardson extrapolation for sufficiently small h the exact solution: the exponent p (order of the scheme): Approximation for the discretization error on grid h:

44 3 Finite Element Method

45 3.1 Interpolation function Approximation by linear combinations of basis functions (shape, interpolation or trial functions) Mehods based on defining the interpolation function on the whole domain: trigonometric functions: collocation and spectral methods loccaly defined polynomials: standard finite element methods

46 One dimensional linear function

47 3.2 Method of weighted residuals

48 4.1 Introduction 4 Finite Volume Method

49 4.2 Approximation of surface integrals

50 4.3 Approximation of volume integrals

51 4.4 Interpolation practices

52 Linear interpolation

53 Quadratic Upwind Interpolation (QUICK)

54 Higher-order schemes

55 5.1 Basic concept A discrete Fourier series 5 Spectral Methods Fourier series for the derivative: Method of evaluating the derivative -- Given f(x), use (36) to compute ^f ; -- Compute the Fourier coefficient of df/dx ; ik q ^f (k q ) ; -- Evaluate the series (37) to obtain df/dx at the grid points. ++ higher derivatives; d 2 f/dx 2 ; -k q2^f (k q ). ++ The error in df/dx decreases exponentially with N when N is large. ++ The cost of computing ^f scales with N 2 (expensive!). The method is made practical by a fast method of computing Fourier transform (FFT); N log 2 N.

56 5.2 A Fourier Galerkin method for the wave equation

57 Example

58 Error

59 7 Time integration Unsteady flows Initial value problem (Initial boundary value problem) Steady flows Boundary value problem t Solution at time t=t t=0 time t=0 Initial condition Steady solution Boundary condition Initial value problem Boundary value problem

60 7.1 Methods for Ordinary Differential Equation (ODE) Two-level methods

61 Two-level methods

62 Predictor-Corrector method

63 Adams-Bushforth methods Mutipoint methods

64 The second order Runge-Kutta method Runge-Kutta methods The fourth order Runge-Kutta method

65 Other methods An implicit three-level second order scheme

66 One dimensional convection equation 8 Stability analysis Finite difference equation; forward in time, centered in space

67 Q: Does a solution of FDE converges to the solution of PDE? PDE approximate FDE Solution of PDE 0? Solution of FDE Ans.: Even if we solve the FDE that approximate the PDE appropriately, the solution may not always be the correct approximation the exact solution of PDE.

68 Consistency 8.1 Consistency, stability and convergence PDE 0 FDE Stability Convergence

69 Lax s equivalence theorem PDE consistent FDE Solution of PDE 0 convergent Solution of FDE stable L : linear operator

70 Truncation error

71 8.2 Von Neumann s method Fourier representation of the error on the grid points

72 FTCS method for 1D convection equation Fourier series of the error Amplification factor G G > 1: Unconditionally unstable

73 Forward in time, forward in space(upwind scheme) CFL (Courant Freedrichs, Levey) condition

74 BTCS method (Backward in time, centered in space) G < 1: Unconditionally stable

75 Stability limit of 1D diffusion equation

76 8.3 Hirt s method

77 Matrix form 8.4 The matrix method Spectral radius of the matrix C (maximum eigenvalue of C)

78 9 Iterative methods for algebraic systems

79 Linear equations : matrix form

80 9.0 Direct methods Gauß elimination A = A 21 /A 11 Forward elimination upper triangular matrix Back substitution + The number of operations (for large n) ~ n 3 / 3 (n 2 / 2 in back substitution) + pivoting (not sparse large systems)

81 9.0.2 LU decomposition Solution of Ax = Q (0) Factorization into lower (L) and upper (U) triangular matrices A = LU (1) Into two stages: U x = y (2) L y = Q (3)

82 9.0.3 Tridiagonal matrix Thomas algorithm / Tridiagonal Matrix Algorithm (TDMA) + the number of operations ~ n (cf n 3,Gauß elimination)

83 Iterative methods : Basic concept Matrix representation of the algebraic equation A u = Q (1) After n iterations approximate solution u n, residual r n : r n = Q -A u n (2) The convergence error: e n = u u n (3) Relation between the error and the residual: A e n = r n (4) The purpose: to drive r n to zero. e n 0

84 Iterative scheme Iterative procedure A u = Q M u n+1 = N u n + B (5) Obvious property at convergence : u n+1 = u n A = M N, B = Q (6) More generally, PA = M N, B = PQ (7) P : pre-conditioning matrix An alternative to (5): -M u n M (u n+1 u n ) = B (M N) u n (8) or M d n = r n d n = u n+1 u n : correction

85 9.1 Jacobi, Gauß-Seidel, SOR method Poisson equation u = f (u i+1,j 2 u i,j + u i-1,j )+(u i,j+1 2 u i,j + u i,j-1 )=f i,j h Jacobi method

86 9.1.3 SOR method Gauß-Seidel method

87 9.1.4 SLOR method Red-Black SOR method

88 9.1.5 Zebra line SOR method

89 9.1.6 Incomplete LU decomposition : Stone s method Idea : an approximate LU factorization as the iteration matrix M M = LU = A + N Strongly implicit procedure (Stone) N (non-zero elements on diagonals corresponding to all non-zero diag. of LU ) N u ~ 0 u* NW ~ a ( u W + u N u P ), u* SE ~ a ( u S + u E u P ) a < 1

90 Elliptic problem parabolic problem ADI method trapezoidal rule in time and CDS in space at time step n+1 The last term ~ O((dt) 3 ) alternating direction implicit (ADI) method splitting or approximate factorization methods

91 9.2 Conjugate Gradient (CG) method Non-linear solvers Newton-like methods global methods Minimization problem descent method Steepest descents Conjugate gradient method A: positive definite with p 1 and p 2 conjugate condition number of A preconditioning C -1 AC -1 Cp=C -1 Q

92 9.3 Multi Grid method

93 Spectral view of errors

94 Fourier modes

95 Restriction

96 Interpolation

97 Coarse grid scheme

98 V-cycle, W-cycle & FMV scheme

99 9.4 Non-linear equations and their solution Newton s method linearization new estimate y y = f(x) x 0 o x 1 x

100 Newton s method System of non-linear equations linearization Matrix of the system: the Jacobian The system of equations

101 Picard iteration approach Other techniques Newton s method

102 9.5 Examples

103 Transonic flow over an airfoil

104 11 Incompressible Navier Stokes (NS) equations Incompressible fluid Incompressible fluid flow Compressible fluid flow Ma < 0.3 Ma > 0.3 density variation d ~ Ma 2 Mach number Ma = (v/c) v : velocity, c : sound speed ex. Ma < 0.3 c air (101.3hPa, 300K) ~ 340 m/s, v < 100 m/s ( 360 km/h ), c water ~ 1000 m/s, v < 300 m/s.

105 Dynamic similitude Reynolds number Re = ex. U = 10 m/s, L = 1 m, v = 0.15 St, Re ~ U = 0.1 m/s, L = 100 m, Re ~ ρ ul ul = η ν u : velocity scale, l : length scale, v : kinematic viscosity

106 11.2 The pressure Poisson equation method Governing equations Navier-Stokes equations Explicit Euler method Pressure Poisson equation

107 11.3 The projection method A system of two component equations The pressure P a projection function The projection step (BTCS) Poisson equation with the Neumann boundary condition :

108 11.4 Implicit Pressure-Correction method The momentum equations (implicit method) Discrete Poisson equation for the pressure : Outer iteration (iterations within one time step): Pressure-correction Modification of the pressure field The (tentative) velocity at node P The relation between the velocity and pressure corrections : For convenience, The discretized continuity equation Pressure-correction equation : The (final) corrected velocities and pressure : Common practice; neglect unknowns ~u SIMPLE algorithm more gentle way

109 Implicit Pressure-Correction method Approximate u by a weighted mean of the neighbour values Neglect ~u in the first correction step. The second correction to the velocity u : Approximate ~u by : The second pressure correction equation: Approximate relation between u and p : The coefficient in the pressure-correction equation A A +... And the last term disappears. SIMPLEC algorithm Essentially an iterative method for pressurecorrection equation with the last term treated explicitly; PISO algorithm Pressure-correction with the last term neglected. p correct the velocity field to obtain u m i. The new pressure field is calculated from pressure equation using ~ u m i instead of ~ um* i SIMPLER algorithm (Patankar 1980)

110 Implicit Pressure-Correction method The SIMPLE algorithm does not converge rapidly due to the neglect of ~u in the pressurecorrection equation.it has been found by trial and error that convergence can be improved if : SIMPLEC, SIMPLER and PISO do not need under-relaxation of the pressure-correction. An optimum relation between the under-relaxation factors for v and p : The velocities are corrected by i.e., ~u is neglected. By assuming that the final pressure correction is a p p : By making use of correction equation, expression for a p : If we use the approximation used in SIMPLEC, the equation reduces to : In the absence of any contribution from source terms, if a steady solution is sought, a p = 1 -a v which has been found nearly optimum and yields almost the same convergence rate as SIMPLEC method.

111 11.5 Other methods Streamfunction-vorticity methods Stream function Kinematic equation Vorticity transport equation -NS equations have been replaced by a set of two PDEs. -A problem : the boundary conditions, especially in complex geometries. -The values of the streamfunction at boundaries. -Vorticity at the boundary is not known in advance. -Vorticity is singular at sharp corners.

112 Artificial compressibility methods Artificial continuity equation beta : an artificial compressibility parameter The pseudo-sound speed: should be much much faster than the vorticity spreads criterion on the lowest value of beta. Typical values are in the range between 0.1 and 10. Obviously, should be small.

113 12 Some remarks on incompressible flows

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

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems Index A-conjugate directions, 83 A-stability, 171 A( )-stability, 171 absolute error, 243 absolute stability, 149 for systems of equations, 154 absorbing boundary conditions, 228 Adams Bashforth methods,

More information

NUMERICAL METHODS FOR ENGINEERING APPLICATION

NUMERICAL METHODS FOR ENGINEERING APPLICATION NUMERICAL METHODS FOR ENGINEERING APPLICATION Second Edition JOEL H. FERZIGER A Wiley-Interscience Publication JOHN WILEY & SONS, INC. New York / Chichester / Weinheim / Brisbane / Singapore / Toronto

More information

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9 Spring 2015 Lecture 9 REVIEW Lecture 8: Direct Methods for solving (linear) algebraic equations Gauss Elimination LU decomposition/factorization Error Analysis for Linear Systems and Condition Numbers

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

Preface. 2 Linear Equations and Eigenvalue Problem 22

Preface. 2 Linear Equations and Eigenvalue Problem 22 Contents Preface xv 1 Errors in Computation 1 1.1 Introduction 1 1.2 Floating Point Representation of Number 1 1.3 Binary Numbers 2 1.3.1 Binary number representation in computer 3 1.4 Significant Digits

More information

Applied Numerical Analysis

Applied Numerical Analysis Applied Numerical Analysis Using MATLAB Second Edition Laurene V. Fausett Texas A&M University-Commerce PEARSON Prentice Hall Upper Saddle River, NJ 07458 Contents Preface xi 1 Foundations 1 1.1 Introductory

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

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

Computation of Incompressible Flows: SIMPLE and related Algorithms

Computation of Incompressible Flows: SIMPLE and related Algorithms Computation of Incompressible Flows: SIMPLE and related Algorithms Milovan Perić CoMeT Continuum Mechanics Technologies GmbH milovan@continuummechanicstechnologies.de SIMPLE-Algorithm I - - - Consider

More information

Numerical Mathematics

Numerical Mathematics Alfio Quarteroni Riccardo Sacco Fausto Saleri Numerical Mathematics Second Edition With 135 Figures and 45 Tables 421 Springer Contents Part I Getting Started 1 Foundations of Matrix Analysis 3 1.1 Vector

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

NUMERICAL COMPUTATION IN SCIENCE AND ENGINEERING

NUMERICAL COMPUTATION IN SCIENCE AND ENGINEERING NUMERICAL COMPUTATION IN SCIENCE AND ENGINEERING C. Pozrikidis University of California, San Diego New York Oxford OXFORD UNIVERSITY PRESS 1998 CONTENTS Preface ix Pseudocode Language Commands xi 1 Numerical

More information

Numerical Methods for Engineers and Scientists

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

More information

5. FVM discretization and Solution Procedure

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

More information

Basic Aspects of Discretization

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

More information

Finite Difference Methods for

Finite Difference Methods for CE 601: Numerical Methods Lecture 33 Finite Difference Methods for PDEs Course Coordinator: Course Coordinator: Dr. Suresh A. Kartha, Associate Professor, Department of Civil Engineering, IIT Guwahati.

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

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

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF MATHEMATICS ACADEMIC YEAR / EVEN SEMESTER QUESTION BANK

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF MATHEMATICS ACADEMIC YEAR / EVEN SEMESTER QUESTION BANK KINGS COLLEGE OF ENGINEERING MA5-NUMERICAL METHODS DEPARTMENT OF MATHEMATICS ACADEMIC YEAR 00-0 / EVEN SEMESTER QUESTION BANK SUBJECT NAME: NUMERICAL METHODS YEAR/SEM: II / IV UNIT - I SOLUTION OF EQUATIONS

More information

A THEORETICAL INTRODUCTION TO NUMERICAL ANALYSIS

A THEORETICAL INTRODUCTION TO NUMERICAL ANALYSIS A THEORETICAL INTRODUCTION TO NUMERICAL ANALYSIS Victor S. Ryaben'kii Semyon V. Tsynkov Chapman &. Hall/CRC Taylor & Francis Group Boca Raton London New York Chapman & Hall/CRC is an imprint of the Taylor

More information

Partial differential equations

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

More information

8. Introduction to Computational Fluid Dynamics

8. Introduction to Computational Fluid Dynamics 8. Introduction to Computational Fluid Dynamics We have been using the idea of distributions of singularities on surfaces to study the aerodynamics of airfoils and wings. This approach was very powerful,

More information

Additive Manufacturing Module 8

Additive Manufacturing Module 8 Additive Manufacturing Module 8 Spring 2015 Wenchao Zhou zhouw@uark.edu (479) 575-7250 The Department of Mechanical Engineering University of Arkansas, Fayetteville 1 Evaluating design https://www.youtube.com/watch?v=p

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

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

Index. C 2 ( ), 447 C k [a,b], 37 C0 ( ), 618 ( ), 447 CD 2 CN 2

Index. C 2 ( ), 447 C k [a,b], 37 C0 ( ), 618 ( ), 447 CD 2 CN 2 Index advection equation, 29 in three dimensions, 446 advection-diffusion equation, 31 aluminum, 200 angle between two vectors, 58 area integral, 439 automatic step control, 119 back substitution, 604

More information

Space-time Discontinuous Galerkin Methods for Compressible Flows

Space-time Discontinuous Galerkin Methods for Compressible Flows Space-time Discontinuous Galerkin Methods for Compressible Flows Jaap van der Vegt Numerical Analysis and Computational Mechanics Group Department of Applied Mathematics University of Twente Joint Work

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

High Speed Aerodynamics. Copyright 2009 Narayanan Komerath

High Speed Aerodynamics. Copyright 2009 Narayanan Komerath Welcome to High Speed Aerodynamics 1 Lift, drag and pitching moment? Linearized Potential Flow Transformations Compressible Boundary Layer WHAT IS HIGH SPEED AERODYNAMICS? Airfoil section? Thin airfoil

More information

Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White

Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White Introduction to Simulation - Lecture 2 Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy Outline Reminder about

More information

First, Second, and Third Order Finite-Volume Schemes for Diffusion

First, Second, and Third Order Finite-Volume Schemes for Diffusion First, Second, and Third Order Finite-Volume Schemes for Diffusion Hiro Nishikawa 51st AIAA Aerospace Sciences Meeting, January 10, 2013 Supported by ARO (PM: Dr. Frederick Ferguson), NASA, Software Cradle.

More information

Math 411 Preliminaries

Math 411 Preliminaries Math 411 Preliminaries Provide a list of preliminary vocabulary and concepts Preliminary Basic Netwon's method, Taylor series expansion (for single and multiple variables), Eigenvalue, Eigenvector, Vector

More information

Chapter 9 Implicit integration, incompressible flows

Chapter 9 Implicit integration, incompressible flows Chapter 9 Implicit integration, incompressible flows The methods we discussed so far work well for problems of hydrodynamics in which the flow speeds of interest are not orders of magnitude smaller than

More information

FDM for parabolic equations

FDM for parabolic equations FDM for parabolic equations Consider the heat equation where Well-posed problem Existence & Uniqueness Mass & Energy decreasing FDM for parabolic equations CNFD Crank-Nicolson + 2 nd order finite difference

More information

Appendix A Computer Programs on the Accompanying CD-ROM

Appendix A Computer Programs on the Accompanying CD-ROM Appendix A Computer Programs on the Accompanying CD-ROM The CD-ROM accompanying this book contains both source and executable computer programs and test cases. They are listed below. Prior to running the

More information

AIMS Exercise Set # 1

AIMS Exercise Set # 1 AIMS Exercise Set #. Determine the form of the single precision floating point arithmetic used in the computers at AIMS. What is the largest number that can be accurately represented? What is the smallest

More information

Chapter 3. Finite Difference Methods for Hyperbolic Equations Introduction Linear convection 1-D wave equation

Chapter 3. Finite Difference Methods for Hyperbolic Equations Introduction Linear convection 1-D wave equation Chapter 3. Finite Difference Methods for Hyperbolic Equations 3.1. Introduction Most hyperbolic problems involve the transport of fluid properties. In the equations of motion, the term describing the transport

More information

TABLE OF CONTENTS INTRODUCTION, APPROXIMATION & ERRORS 1. Chapter Introduction to numerical methods 1 Multiple-choice test 7 Problem set 9

TABLE OF CONTENTS INTRODUCTION, APPROXIMATION & ERRORS 1. Chapter Introduction to numerical methods 1 Multiple-choice test 7 Problem set 9 TABLE OF CONTENTS INTRODUCTION, APPROXIMATION & ERRORS 1 Chapter 01.01 Introduction to numerical methods 1 Multiple-choice test 7 Problem set 9 Chapter 01.02 Measuring errors 11 True error 11 Relative

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 11 Partial Differential Equations Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002.

More information

Modeling Unsteady Flow in Turbomachinery Using a Harmonic Balance Technique

Modeling Unsteady Flow in Turbomachinery Using a Harmonic Balance Technique Modeling Unsteady Flow in Turbomachinery Using a Harmonic Balance Technique Torsten Palenschat 317220 30.04.2014 Master seminar CES WS 2013/2014 Center for Computational Engineering Sciences RWTH Aachen

More information

(f(x) P 3 (x)) dx. (a) The Lagrange formula for the error is given by

(f(x) P 3 (x)) dx. (a) The Lagrange formula for the error is given by 1. QUESTION (a) Given a nth degree Taylor polynomial P n (x) of a function f(x), expanded about x = x 0, write down the Lagrange formula for the truncation error, carefully defining all its elements. How

More information

FUNDAMENTALS OF FINITE DIFFERENCE METHODS

FUNDAMENTALS OF FINITE DIFFERENCE METHODS FUNDAMENTALS OF FINITE DIFFERENCE METHODS By Deep Gupta 3 rd Year undergraduate, Mechanical Engg. Deptt., IIT Bombay Supervised by: Prof. Gautam Biswas, IIT Kanpur Acknowledgements It has been a pleasure

More information

MATHEMATICAL METHODS INTERPOLATION

MATHEMATICAL METHODS INTERPOLATION MATHEMATICAL METHODS INTERPOLATION I YEAR BTech By Mr Y Prabhaker Reddy Asst Professor of Mathematics Guru Nanak Engineering College Ibrahimpatnam, Hyderabad SYLLABUS OF MATHEMATICAL METHODS (as per JNTU

More information

Some notes about PDEs. -Bill Green Nov. 2015

Some notes about PDEs. -Bill Green Nov. 2015 Some notes about PDEs -Bill Green Nov. 2015 Partial differential equations (PDEs) are all BVPs, with the same issues about specifying boundary conditions etc. Because they are multi-dimensional, they can

More information

MULTIGRID CALCULATIONS FOB. CASCADES. Antony Jameson and Feng Liu Princeton University, Princeton, NJ 08544

MULTIGRID CALCULATIONS FOB. CASCADES. Antony Jameson and Feng Liu Princeton University, Princeton, NJ 08544 MULTIGRID CALCULATIONS FOB. CASCADES Antony Jameson and Feng Liu Princeton University, Princeton, NJ 0544 1. Introduction Development of numerical methods for internal flows such as the flow in gas turbines

More information

Cranfield University, Cranfield, Bedfordshire, MK43 0AL, United Kingdom. Cranfield University, Cranfield, Bedfordshire, MK43 0AL, United Kingdom

Cranfield University, Cranfield, Bedfordshire, MK43 0AL, United Kingdom. Cranfield University, Cranfield, Bedfordshire, MK43 0AL, United Kingdom MultiScience - XXX. microcad International Multidisciplinary Scientific Conference University of Miskolc, Hungary, 21-22 April 2016, ISBN 978-963-358-113-1 NUMERICAL INVESTIGATION OF AN INCOMPRESSIBLE

More information

Department of Mathematics California State University, Los Angeles Master s Degree Comprehensive Examination in. NUMERICAL ANALYSIS Spring 2015

Department of Mathematics California State University, Los Angeles Master s Degree Comprehensive Examination in. NUMERICAL ANALYSIS Spring 2015 Department of Mathematics California State University, Los Angeles Master s Degree Comprehensive Examination in NUMERICAL ANALYSIS Spring 2015 Instructions: Do exactly two problems from Part A AND two

More information

Time stepping methods

Time stepping methods Time stepping methods ATHENS course: Introduction into Finite Elements Delft Institute of Applied Mathematics, TU Delft Matthias Möller (m.moller@tudelft.nl) 19 November 2014 M. Möller (DIAM@TUDelft) Time

More information

Review for Exam 2 Ben Wang and Mark Styczynski

Review for Exam 2 Ben Wang and Mark Styczynski Review for Exam Ben Wang and Mark Styczynski This is a rough approximation of what we went over in the review session. This is actually more detailed in portions than what we went over. Also, please note

More information

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 1 / 29 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS Hierarchy of Mathematical Models 1 / 29 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 2 / 29

More information

Modeling, Simulating and Rendering Fluids. Thanks to Ron Fediw et al, Jos Stam, Henrik Jensen, Ryan

Modeling, Simulating and Rendering Fluids. Thanks to Ron Fediw et al, Jos Stam, Henrik Jensen, Ryan Modeling, Simulating and Rendering Fluids Thanks to Ron Fediw et al, Jos Stam, Henrik Jensen, Ryan Applications Mostly Hollywood Shrek Antz Terminator 3 Many others Games Engineering Animating Fluids is

More information

A finite-volume algorithm for all speed flows

A finite-volume algorithm for all speed flows A finite-volume algorithm for all speed flows F. Moukalled and M. Darwish American University of Beirut, Faculty of Engineering & Architecture, Mechanical Engineering Department, P.O.Box 11-0236, Beirut,

More information

Numerical Methods for Engineers. and Scientists. Applications using MATLAB. An Introduction with. Vish- Subramaniam. Third Edition. Amos Gilat.

Numerical Methods for Engineers. and Scientists. Applications using MATLAB. An Introduction with. Vish- Subramaniam. Third Edition. Amos Gilat. Numerical Methods for Engineers An Introduction with and Scientists Applications using MATLAB Third Edition Amos Gilat Vish- Subramaniam Department of Mechanical Engineering The Ohio State University Wiley

More information

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C.

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C. Lecture 9 Approximations of Laplace s Equation, Finite Element Method Mathématiques appliquées (MATH54-1) B. Dewals, C. Geuzaine V1.2 23/11/218 1 Learning objectives of this lecture Apply the finite difference

More information

Computational Fluid Dynamics-1(CFDI)

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

More information

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 13

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 13 REVIEW Lecture 12: Spring 2015 Lecture 13 Grid-Refinement and Error estimation Estimation of the order of convergence and of the discretization error Richardson s extrapolation and Iterative improvements

More information

Finite Differences: Consistency, Stability and Convergence

Finite Differences: Consistency, Stability and Convergence Finite Differences: Consistency, Stability and Convergence Varun Shankar March, 06 Introduction Now that we have tackled our first space-time PDE, we will take a quick detour from presenting new FD methods,

More information

fluid mechanics as a prominent discipline of application for numerical

fluid mechanics as a prominent discipline of application for numerical 1. fluid mechanics as a prominent discipline of application for numerical simulations: experimental fluid mechanics: wind tunnel studies, laser Doppler anemometry, hot wire techniques,... theoretical fluid

More information

Finite Difference Method for PDE. Y V S S Sanyasiraju Professor, Department of Mathematics IIT Madras, Chennai 36

Finite Difference Method for PDE. Y V S S Sanyasiraju Professor, Department of Mathematics IIT Madras, Chennai 36 Finite Difference Method for PDE Y V S S Sanyasiraju Professor, Department of Mathematics IIT Madras, Chennai 36 1 Classification of the Partial Differential Equations Consider a scalar second order partial

More information

Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement

Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement Romain Teyssier CEA Saclay Romain Teyssier 1 Outline - Euler equations, MHD, waves, hyperbolic

More information

PARTIAL DIFFERENTIAL EQUATIONS

PARTIAL DIFFERENTIAL EQUATIONS MATHEMATICAL METHODS PARTIAL DIFFERENTIAL EQUATIONS I YEAR B.Tech By Mr. Y. Prabhaker Reddy Asst. Professor of Mathematics Guru Nanak Engineering College Ibrahimpatnam, Hyderabad. SYLLABUS OF MATHEMATICAL

More information

Stabilization and Acceleration of Algebraic Multigrid Method

Stabilization and Acceleration of Algebraic Multigrid Method Stabilization and Acceleration of Algebraic Multigrid Method Recursive Projection Algorithm A. Jemcov J.P. Maruszewski Fluent Inc. October 24, 2006 Outline 1 Need for Algorithm Stabilization and Acceleration

More information

Introduction to numerical simulation of fluid flows

Introduction to numerical simulation of fluid flows Introduction to numerical simulation of fluid flows Mónica de Mier Torrecilla Technical University of Munich Winterschool April 2004, St. Petersburg (Russia) 1 Introduction The central task in natural

More information

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t)

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t) IV. DIFFERENTIAL RELATIONS FOR A FLUID PARTICLE This chapter presents the development and application of the basic differential equations of fluid motion. Simplifications in the general equations and common

More information

Multi-Factor Finite Differences

Multi-Factor Finite Differences February 17, 2017 Aims and outline Finite differences for more than one direction The θ-method, explicit, implicit, Crank-Nicolson Iterative solution of discretised equations Alternating directions implicit

More information

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

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

More information

Divergence Formulation of Source Term

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

More information

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

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

Numerical Solution of partial differential equations

Numerical Solution of partial differential equations G. D. SMITH Brunei University Numerical Solution of partial differential equations FINITE DIFFERENCE METHODS THIRD EDITION CLARENDON PRESS OXFORD Contents NOTATION 1. INTRODUCTION AND FINITE-DIFFERENCE

More information

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA Introduction to Finite and Spectral Element Methods Using MATLAB Second Edition C. Pozrikidis University of Massachusetts Amherst, USA (g) CRC Press Taylor & Francis Group Boca Raton London New York CRC

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

Answers to Exercises Computational Fluid Dynamics

Answers to Exercises Computational Fluid Dynamics Answers to Exercises Computational Fluid Dynamics Exercise - Artificial diffusion upwind computations.9 k=. exact.8 k=..7 k=..6 k=..5.4.3.2...2.3.4.5.6.7.8.9 x For k =.,. and., and for N = 2, the discrete

More information

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Per-Olof Persson and Jaime Peraire Massachusetts Institute of Technology 7th World Congress on Computational Mechanics

More information

Computer Aided Design of Thermal Systems (ME648)

Computer Aided Design of Thermal Systems (ME648) Computer Aided Design of Thermal Systems (ME648) PG/Open Elective Credits: 3-0-0-9 Updated Syallabus: Introduction. Basic Considerations in Design. Modelling of Thermal Systems. Numerical Modelling and

More information

ENGINEERING MATHEMATICS I. CODE: 10 MAT 11 IA Marks: 25 Hrs/Week: 04 Exam Hrs: 03 PART-A

ENGINEERING MATHEMATICS I. CODE: 10 MAT 11 IA Marks: 25 Hrs/Week: 04 Exam Hrs: 03 PART-A ENGINEERING MATHEMATICS I CODE: 10 MAT 11 IA Marks: 25 Hrs/Week: 04 Exam Hrs: 03 Total Hrs: 52 Exam Marks:100 PART-A Unit-I: DIFFERENTIAL CALCULUS - 1 Determination of n th derivative of standard functions-illustrative

More information

Preface to the Second Edition. Preface to the First Edition

Preface to the Second Edition. Preface to the First Edition n page v Preface to the Second Edition Preface to the First Edition xiii xvii 1 Background in Linear Algebra 1 1.1 Matrices................................. 1 1.2 Square Matrices and Eigenvalues....................

More information

1. Introduction Some Basic Concepts

1. Introduction Some Basic Concepts 1. Introduction Some Basic Concepts 1.What is a fluid? A substance that will go on deforming in the presence of a deforming force, however small 2. What Properties Do Fluids Have? Density ( ) Pressure

More information

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

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

More information

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

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

Particle-Simulation Methods for Fluid Dynamics

Particle-Simulation Methods for Fluid Dynamics Particle-Simulation Methods for Fluid Dynamics X. Y. Hu and Marco Ellero E-mail: Xiangyu.Hu and Marco.Ellero at mw.tum.de, WS 2012/2013: Lectures for Mechanical Engineering Institute of Aerodynamics Technical

More information

A Non-Intrusive Polynomial Chaos Method For Uncertainty Propagation in CFD Simulations

A Non-Intrusive Polynomial Chaos Method For Uncertainty Propagation in CFD Simulations An Extended Abstract submitted for the 44th AIAA Aerospace Sciences Meeting and Exhibit, Reno, Nevada January 26 Preferred Session Topic: Uncertainty quantification and stochastic methods for CFD A Non-Intrusive

More information

Tutorial 2. Introduction to numerical schemes

Tutorial 2. Introduction to numerical schemes 236861 Numerical Geometry of Images Tutorial 2 Introduction to numerical schemes c 2012 Classifying PDEs Looking at the PDE Au xx + 2Bu xy + Cu yy + Du x + Eu y + Fu +.. = 0, and its discriminant, B 2

More information

Ordinary Differential Equations

Ordinary Differential Equations Ordinary Differential Equations We call Ordinary Differential Equation (ODE) of nth order in the variable x, a relation of the kind: where L is an operator. If it is a linear operator, we call the equation

More information

Introduction to Numerical Analysis

Introduction to Numerical Analysis J. Stoer R. Bulirsch Introduction to Numerical Analysis Second Edition Translated by R. Bartels, W. Gautschi, and C. Witzgall With 35 Illustrations Springer Contents Preface to the Second Edition Preface

More information

Solution Methods. Steady convection-diffusion equation. Lecture 05

Solution Methods. Steady convection-diffusion equation. Lecture 05 Solution Methods Steady convection-diffusion equation Lecture 05 1 Navier-Stokes equation Suggested reading: Gauss divergence theorem Integral form The key step of the finite volume method is to integrate

More information

Classification of partial differential equations and their solution characteristics

Classification of partial differential equations and their solution characteristics 9 TH INDO GERMAN WINTER ACADEMY 2010 Classification of partial differential equations and their solution characteristics By Ankita Bhutani IIT Roorkee Tutors: Prof. V. Buwa Prof. S. V. R. Rao Prof. U.

More information

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers Applied and Computational Mathematics 2017; 6(4): 202-207 http://www.sciencepublishinggroup.com/j/acm doi: 10.11648/j.acm.20170604.18 ISSN: 2328-5605 (Print); ISSN: 2328-5613 (Online) A Robust Preconditioned

More information

NUMERICAL MATHEMATICS AND COMPUTING

NUMERICAL MATHEMATICS AND COMPUTING NUMERICAL MATHEMATICS AND COMPUTING Fourth Edition Ward Cheney David Kincaid The University of Texas at Austin 9 Brooks/Cole Publishing Company I(T)P An International Thomson Publishing Company Pacific

More information

Numerical Cornp u tat ion

Numerical Cornp u tat ion Numerical Cornp u tat ion n INTERNAL AND EXTERNAL FLOWS Volume 1 : Fundamentals of Numerical Discretization Charles Hirsch Department of Fluid Mechanics, Vrije Universiteit Brussel, Brussels, Belgium A

More information

Numerical Methods. Scientists. Engineers

Numerical Methods. Scientists. Engineers Third Edition Numerical Methods for Scientists and Engineers K. Sankara Rao Numerical Methods for Scientists and Engineers Numerical Methods for Scientists and Engineers Third Edition K. SANKARA RAO Formerly,

More information

Computational Methods

Computational Methods Numerical Computational Methods Revised Edition P. B. Patil U. P. Verma Alpha Science International Ltd. Oxford, U.K. CONTENTS Preface List ofprograms v vii 1. NUMER1CAL METHOD, ERROR AND ALGORITHM 1 1.1

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

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

Length Learning Objectives Learning Objectives Assessment

Length Learning Objectives Learning Objectives Assessment Universidade Federal Fluminense PGMEC Course: Advanced Computational Fluid Dynamics Coordinator: Vassilis Theofilis Academic Year: 2018, 2 nd Semester Length: 60hrs (48hrs classroom and 12hrs tutorials)

More information

Finite volume method on unstructured grids

Finite volume method on unstructured grids Finite volume method on unstructured grids 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

Eigenmode Analysis of Boundary Conditions for the One-dimensional Preconditioned Euler Equations

Eigenmode Analysis of Boundary Conditions for the One-dimensional Preconditioned Euler Equations NASA/CR-1998-208741 ICASE Report No. 98-51 Eigenmode Analysis of Boundary Conditions for the One-dimensional Preconditioned Euler Equations David L. Darmofal Massachusetts Institute of Technology, Cambridge,

More information

A STUDY OF MULTIGRID SMOOTHERS USED IN COMPRESSIBLE CFD BASED ON THE CONVECTION DIFFUSION EQUATION

A STUDY OF MULTIGRID SMOOTHERS USED IN COMPRESSIBLE CFD BASED ON THE CONVECTION DIFFUSION EQUATION ECCOMAS Congress 2016 VII European Congress on Computational Methods in Applied Sciences and Engineering M. Papadrakakis, V. Papadopoulos, G. Stefanou, V. Plevris (eds.) Crete Island, Greece, 5 10 June

More information