Module 3: BASICS OF CFD. Part A: Finite Difference Methods

Size: px
Start display at page:

Download "Module 3: BASICS OF CFD. Part A: Finite Difference Methods"

Transcription

1 Module 3: BASICS OF CFD Part A: Finite Difference Methods

2 THE CFD APPROACH Assembling the governing equations Identifying flow domain and boundary conditions Geometrical discretization of flow domain Discretization of the governing equations Incorporation of boundary conditions Solution of resulting algebraic equations Post-solution analysis and reformulation, if needed

3 OUTLINE Basics of finite difference (FD) methods FD approximation of arbitrary accuracy FD formulas for higher derivatives Application to an elliptic problem FD for time-dependent problems FD on non-uniform meshes Closure

4 Basics of Finite Difference Methods FD methods are quite old and somewhat dated for CFD problems but serve as a point of departure for CFD studies The principal idea of CFD methods is to replace a governing partial differential equation by an equivalent and approximate set of algebraic equations Finite difference techniques are one of several options for this discretization of the governing equations In finite difference methods, each derivative of the pde is replaced by an equivalent finite difference approximation

5 Basics of Finite Difference Methods The basis of a finite difference method is the Taylor series expansion of a function. Consider a continuous function f(x). Its value at neighbouring points can be expressed in terms of a Taylor series as (1) f(x+ Δx) = f(x) + df/dx x (Δx) + d 2 f/dx 2 x (Δx 2 )/ d n f/dx n x (Δx n )/n +.. The above series converges if Δx is small and f(x) is differentiable For a converging series, successive terms are progressively smaller

6 FD Approximation for a First Derivative The terms in the Taylor series expansion can be rearranged to give Or df/dx x = [f(x+ Δx) - f(x)] / Δx - d 2 f/dx 2 x (Δx)/2 - -d n f/dx n x (Δx n-1 )/n -... (2) df/dx x [f(x+ Δx) - f(x)] / Δx + O(Δx) Here O(Δx) implies that the leading term in the neglected terms of the order of Δx, i.e., the error in the approximation reduces by a factor of 2 if Δx is halved. Equation (2) is therefore a first order-accurate approximation for the first derivative.

7 Other Approximations for a First Derivative Other approximations are also possible. Writing the Taylor series expansion for f(x- Δx), we have (3) f(x-δx) = f(x) - df/dx x (Δx) + d 2 f/dx 2 x (Δx 2 )/ d n f/dx n x (Δx n )/n + Equation (3) can be rearranged to give another first order approximation : (4) df/dx x [f(x) - f(x-δx)] / Δx + O(Δx) Subtracting (3) from (1) gives a second order approximation for df/dx x : (5) df/dx x [f(x+ Δx) - f(x-δx)] / (2Δx) + O(Δx 2 )

8 FD Approximations on a Uniform Mesh Consider a uniform mesh with a spacing of Δx over an interval [0, L] Denoting the mesh index by i, we can write Then f i = f(x i ) = f(i Δx) and f i+1 = f [(i+1) Δx] and so on (2) df/dx x [f(x+ Δx) - f(x)] / Δx = (f i+1 - f i )/Δx + O(Δx) (3) df/dx x [f(x) - f(x- Δx) ] / Δx = (f i - f i-1 )/Δx + O(Δx) (5) df/dx x [f(x+ Δx) - f(x-δx)] / (2Δx) = (f i+1 - f i-1 )/(2Δx) + O(Δx 2 ) are the forward one-sided backward one-sided central symmetric differencing formulas, respectively, for df/dx at x or node i One-sided formulas are necessary at ends of domains

9 Graphical representation of FD approximation of first derivative f-forward differencing b-backward differencing c-central differencing t-true slope

10 Higher Order Accuracy Higher order of accuracy of approximation can be obtained by including more number of adjacent points Let us seek a third-order, one-sided approximation for u(x). This requires four points and will be of the form (6) du/dx) i = [a u i + b u i+1 + c u i+2 + d u i+3 ]/ Δx + O(Δx 3 ) This is equivalent to writing (6) as (7) du/dx) i = [a u i + b u i+1 + c u i+2 + d u i+3 ]/ Δx + (0) d 2 u/dx 2 x (Δx) + (0)d 3 u/dx 3 x (Δx 2 ) + (e) d 4 u/dx 4 x (Δx 3 ) or (8) a u i + b u i+1 + c u i+2 + d u i+3 = + du/dx x (Δx) + (0) d 2 u/dx 2 x (Δx 2 ) + (0)d 3 u/dx 3 x (Δx 3 ) - (e) d 4 u/dx 4 x (Δx 4 ) How to find a, b, c and d?

11 Third-Order, One-sided Formula Expand u i+1, u i+2 and u i+3 in Taylor series about u i : (9a) u i+1 = u(x+ 1Δx) = u(x) + du/dx x (Δx) + d 2 u/dx 2 x (Δx) 2 / (9b) u i+2 = u(x+ 2Δx) = u(x) + du/dx x (2Δx) + d 2 u/dx 2 x (2Δx) 2 / (9c) u i+3 = u(x+ 3Δx) = u(x) + du/dx x (3Δx) + d 2 u/dx 2 x (3Δx) 2 / Find { a u i + b (9a) + c(9b) + d (9c) } and rearrange to get (10) a u i + b u i+1 + c u i+2 + d u i+3 = p u +q du/dx x (Δx) + r d 2 u/dx 2 x (Δx 2 ) + s d 3 u/dx 3 x (Δx 3 ) + t d 4 u/dx 4 x (Δx 4 ) (8) a u i + b u i+1 + c u i+2 + d u i+3 = + du/dx x (Δx) + (0) d 2 u/dx 2 x (Δx 2 ) + (0)d 3 u/dx 3 x (Δx 3 ) - (e) d 4 u/dx 4 x (Δx 4 ) Compare the coefficients of (8) and (10) to get a = -11/6 b = 3 c = -3/2 d = 1/3 or (11) du/dx) i = [-11 u i + 18 u i+1-9 u i u i+3 ]/ (6Δx) + O(Δx 3 )

12 Higher Derivatives Finite difference approximation for second derivative: or d 2 u/dx 2 ) i = [d/dx(du/dx)] i [ (du/dx) i+1/2 - (du/dx) i-1/2 ] / Δx [ (u i+1 - u i )/ Δx - (u i - u i-1 )/ Δx ] / Δx (12) d 2 u/dx 2 ) i [ (u i+1-2 u i + u i-1 ) ] / Δx 2 Taylor series evaluation of equation (11) shows that the approximation is second order accurate; thus, (12a) d 2 u/dx 2 ) i = [ (u i+1-2 u i + u i-1 ) ] / Δx 2 + O(Δx 2 ) Note that use of central differences for the second derivative requires three points, viz., (i-1), i, (i+1), for a second order accurate formula

13 Other Formulas for Higher Derivatives Using forward differencing throughout, one can get the following first order accurate formula involving three points for the second derivative: or d 2 u/dx 2 ) i = [d/dx( du/dx)] i [ (du/dx) i+1 - (du/dx) i ] / Δx [ (u i+2 - u i+1 )/ Δx - (u i+1 - u i )/ Δx ] / Δx (13) d 2 u/dx 2 ) i [ (u i+2-2 u i+1 + u i ) ] / Δx 2 + O(Δx) A central, second order scheme for the third derivative needs four points: (14) d 3 u/dx 3 ) i = [ (u i+2-2 u i u i-1 - u i-2 ) ] / (2Δx 3 ) + O(Δx 2 ) If p = order of derivative, q = order of accuracy and n = no of points, then n = p + q -1 for central schemes n = p + q for one-sided schemes

14 Mixed Derivatives Mixed derivatives can occur as a result of coordinate transformation to a non-orthogonal system (for example, to take account of non-regular shape of the flow domain). Straightforward application of the method for higher derivatives: or 2 u/ x y) i,j = [ / x ( u/ y)] i,j [( u/ y) i+1,j - ( u/ y) i-1,j ] / (2Δx) [ (u i+1,j+1 - u i+1,j-1 )/ 2Δy - (u i-1,j+1 - u i-1,j-1 )/ 2Δy ] / (2Δx) (15) 2 u/ x y)i,j [(u i+1,j+1 -u i+1,j-1 - u i-1,j+1 + u i-1,j-1 )] / (4 ΔxΔy) + O(Δx 2, Δy 2 ) A large variety of schemes possible

15 Example: 2-D Poisson Equation (16) 2 u/ x u/ y 2 = f 0 < x < L and 0 < y < W with Dirichlet boundary conditions: u (x,y) = g(x,y) on boundary Write 2 u/ x 2 ) i,j [(u i+1,j -2u i,j + u i-1,j )] / (Δx 2 ) + O(Δx 2 ) and 2 u/ y 2 ) i,j [(u i,j+1-2u i,j + u i,j-1 )] / (Δy 2 ) + O(Δy 2 ) and substitute in (16) to get (17) [(u i+1,j -2u i,j + u i-1,j )] / (Δx 2 ) + [(u i,j+1-2u i,j + u i,j-1 )] / (Δy 2 ) = f ij + O(Δx 2, Δy 2 ) With Dirichlet boundary conditions, equation (17) would be valid for 2 < i < N i 2 < j < N j Results in (N i -1) (N j -1) algebraic equations to be solved for u(i,j)

16 2-d grid

17 Boundary conditions Boundary conditions over AB: Dirichlet boundary conditions: u (x i,y 1 ) = g(x i,y 1 ) on AB Normal gradient specified: du/dy i, 1 = c 1 for all i at j = 1 Convective boundary condition: q i,1 = -k u/ y i,1 = h*(u inf u i,1 ); h and u inf given

18 Poisson Equation: Other Boundary Conditions Normal gradient specified, e.g, du/dy = c 1 for all i at j = N j Values of u(i, N j ) not known and have to be determined For these boundary points, du/dy (u i,nj-1 -u i,nj )/ Δy = c 1 or u i,nj - u i,nj-1 = c 1 * Δy first order accurate Equations for the interior points remain the same For second order accuracy, one can write du/dy (a u i,nj-2 + b u i,nj-1 + c u i,nj )/ Δy = c1 Convective boundary condition: q w = h*(u inf -u w ); h and u inf given This can be implemented by noting that q w = -k du/dy Thus, h*(u inf - u i,nj ) = -k*(a u i,nj-2 + b u i,nj-1 + c u i,nj )/ Δy which gives the necessary algebraic equation for the boundary point. (Ni-1) (Nj) algebraic equations to be solved for u(i,j)

19 Discretization of Time Domain Consider the unsteady heat conduction problem: T/ t = 2 T/ x 2 (18) Denote T(x,t ) = T(i Δx, n Δt) = T i n We seek discretization of eqn. (18) of the form (19) T/ t ) i n = 2 T/ x 2 ) i n Evaluate LHS of (19) using forward differencing as (20) T/ t ) n i = (T n+1 i - T in ) / Δt + O (Δt) But several options for RHS even if we choose, say, central differencing for 2 T/ x 2

20 Explicit and Implicit Schemes Put 2 T/ x 2 ) i,n = (T i+1,n - 2 T i,n + T i-1,n )/ Δx 2 + O(Δx 2 ) (21) and substitute (20) and (21) in (19) to get Explicit equation for T i,n+1 : (T i,n+1 - T i,n )/ Δt = (T i+1,n - 2 T i,n + T i-1,n )/ Δx 2 or T i,n+1 = T i,n + Δt/Δx 2 (T i+1,n - 2 T i,n + T i-1,n ) + O(Δt, Δx 2 ) (22) Put 2 T/ x 2 ) i,n = (T i+1,n+1-2 T i,n+1 + T i-1,n+1 )/ Δx 2 + O(Δx 2 ) (23) and substitute (20) and (21) in (19) to get Implicit equation for T i,n+1 : (T i,n+1 - T i,n )/ Δt = (T i+1,n+1-2 T i,n+1 + T i-1,n+1 )/ Δx 2 or (1+ 2 Δt/Δx 2 ) T i,n+1 = T i,n + Δt/Δx 2 (T i+1,n+1 + T i-1,n+1 ) + O(Δt, Δx 2 ) (24)

21 Put T i,n = (T i, n-1 + T i,n+1 )/2 to get the DuFort-Frankel scheme: Other Schemes (25) (T i,n+1 - T i,n-1 )/ (2Δt) = (T i+1,n - T i,n+1 +T i,n-1 + T i-1,n )/ Δx 2 + O(Δt 2, Δx 2 ) Explicit, second order accurate and unconditionally stable Evaluate RHS at (n+1/2) as (RHS,n + RHS,n+1)/2 and put in (19) to get the Crank-Nicolson scheme: (26) -r T i-1,n+1 +(2+2r) T i,n+1 - rt i+1,n+1 = rt i-1,n + (2-2r)T i,n + rt i+1,n where r = Δt/Δx 2 Implicit, second order accurate and unconditionally stable

22 Explicit vs Implicit Methods Explicit methods are simple to program and allow marching forward in time point by point from given initial condition Implicit methods are more difficult to program and require simultaneous solution of algebraic equations at each time step to get the solution Explicit methods are generally less stable than implicit methods and may give unphysical solutions if the marching time step is too large Too-large a time step, which is possible with implicit methods, may result in less accuracy and instability in non-linear problems

23 Non-uniform Meshes The methods discussed above can be extended to non-uniform meshes but may have to be done with care so as not to lose an order of accuracy : du/dx)i = {ui+1 (Δxi-1) 2 - ui-1(δxi) 2 + ui[(δxi-1) 2 - (Δxi) 2 ]} / {(Δxi-1) (Δxi) (Δxi-1 + Δxi)} + O{(Δxi) 2 } where Δxi = xi+1 - xi etc Highly non-uniform and distorted meshes should be avoided where possible

24 Closure Finite difference techniques can be used to systematically develop approximate formula for derivatives of a function on a structured mesh Formulas of desired accuracy level can be obtained for a derivative provided sufficient number of points are included in the formula Discretized equations of partial differential equations can be obtained by replacing the derivatives with finite difference formulas The resulting equations are coupled of algebraic equations which may be non-linear for non-linear equations and require simultaneous solution The issue of stability is brought into play for time-dependent problems

25 Need for Analysis Discretization of governing equations using FD or FE or FV techniques gives a set of discretized equations involving variable values at neighbouring points These discretized equations are the ones that are actually solved to determine the variable values at grid nodes Discretization is not unique and for the same PDE, different discretized equations can be obtained, e.g. discretization can be done to different orders of accuracy Are all discretizations equivalent? Or are some superior? How can we ensure that the numerical solution is correct?

26 A Simple Case Study Consider the linear convection equation u t u + a x = 0 n+ 1 n n n i i ( i i 1 FTBS : u = u σ u u ) n+ 1 n n n i i i+ 1 i FTCS: u = u σ ( u u 1) / 2 σ = aδt/δx Courant no n+ 1 n n n i = i ( i+ 1 i FTFS : u u σ u u )

27 The True Solution Take a = 1 m/s; initial conditions : u(x,0) = f(x) where f(x) = 1 for 0.1 x 0.2 and f(x) = 0 otherwise True solution: initial pulse gets convected in x-direction at 1 m/s u(x,t) = u(x-at) u x

28 FTBS Solution for σ 1 at t = 0.1 s f(x, 0.1) x (m) Peak location predicted correctly, but the square pulse has been rounded Decreasing amplitude with decreasing σ

29 FTBS Solution for σ 1 at t = 0.1 s 4 Fig I.1b. FTBS scheme with various Courant numbers at t=0.1 s f(x, 0.1) x (m) Both shape and amplitude predicted poorly for σ > 1

30 FTCS Solution for σ 1 at t = 0.1 s Discretization second-order accurate in space but... 8 Fig I.2a FTCS scheme with various Courant numbers at t=0.1s 6 4 f(x, t0) x (m)

31 FTFS Solution for σ 1 at t = 0.05 s Solution wildly fluctuating for all Courant numbers f(x, t0) Fig I.2b FTFS scheme with various Courant numbers at t=0.05 s x (m)

32 Need for Analysis Identified Different solutions ranging from exact to thoroughly unsatisfactory obtained for this simple, linear equation Behaviour of the solution appears to depend on choice of Δt and Δx Need a formal analysis to determine the choice of parameters to yield an accurate solution Three conditions for a good solution: Consistency : discretized equation pde Stability : exact solution of disc eqn computed solution Convergence: computed solution exact solution of pde Equivalence theorem of Lax (1954): For a well-posed linear initial value problem with a consistent discretization, stability is necessary and sufficient for convergence Convergence assures us that grid independent solution = exact solution of the governing equation

Basics of Discretization Methods

Basics of Discretization Methods Basics of Discretization Methods In the finite difference approach, the continuous problem domain is discretized, so that the dependent variables are considered to exist only at discrete points. Derivatives

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

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

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

Characteristic finite-difference solution Stability of C C (CDS in time/space, explicit): Example: Effective numerical wave numbers and dispersion

Characteristic finite-difference solution Stability of C C (CDS in time/space, explicit): Example: Effective numerical wave numbers and dispersion Spring 015 Lecture 14 REVIEW Lecture 13: Stability: Von Neumann Ex.: 1st order linear convection/wave eqn., F-B scheme Hyperbolic PDEs and Stability nd order wave equation and waves on a string Characteristic

More information

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

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

More information

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

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

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

The Finite Difference Method

The Finite Difference Method Chapter 5. The Finite Difference Method This chapter derives the finite difference equations that are used in the conduction analyses in the next chapter and the techniques that are used to overcome computational

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

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

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

Lecture 4.2 Finite Difference Approximation

Lecture 4.2 Finite Difference Approximation Lecture 4. Finite Difference Approimation 1 Discretization As stated in Lecture 1.0, there are three steps in numerically solving the differential equations. They are: 1. Discretization of the domain by

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

MIT (Spring 2014)

MIT (Spring 2014) 18.311 MIT (Spring 014) Rodolfo R. Rosales May 6, 014. Problem Set # 08. Due: Last day of lectures. IMPORTANT: Turn in the regular and the special problems stapled in two SEPARATE packages. Print your

More information

Chapter 5. Formulation of FEM for Unsteady Problems

Chapter 5. Formulation of FEM for Unsteady Problems Chapter 5 Formulation of FEM for Unsteady Problems Two alternatives for formulating time dependent problems are called coupled space-time formulation and semi-discrete formulation. The first one treats

More information

Introduction to numerical schemes

Introduction to numerical schemes 236861 Numerical Geometry of Images Tutorial 2 Introduction to numerical schemes Heat equation The simple parabolic PDE with the initial values u t = K 2 u 2 x u(0, x) = u 0 (x) and some boundary conditions

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

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

Lecture Notes on Numerical Schemes for Flow and Transport Problems

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

More information

Lecture Notes on Numerical Schemes for Flow and Transport Problems

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

More information

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

Finite Difference Methods (FDMs) 2

Finite Difference Methods (FDMs) 2 Finite Difference Methods (FDMs) 2 Time- dependent PDEs A partial differential equation of the form (15.1) where A, B, and C are constants, is called quasilinear. There are three types of quasilinear equations:

More information

Discretization of Convection Diffusion type equation

Discretization of Convection Diffusion type equation Discretization of Convection Diffusion type equation 10 th Indo German Winter Academy 2011 By, Rajesh Sridhar, Indian Institute of Technology Madras Guides: Prof. Vivek V. Buwa Prof. Suman Chakraborty

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

Notation Nodes are data points at which functional values are available or at which you wish to compute functional values At the nodes fx i

Notation Nodes are data points at which functional values are available or at which you wish to compute functional values At the nodes fx i LECTURE 6 NUMERICAL DIFFERENTIATION To find discrete approximations to differentiation (since computers can only deal with functional values at discrete points) Uses of numerical differentiation To represent

More information

High-order ADI schemes for convection-diffusion equations with mixed derivative terms

High-order ADI schemes for convection-diffusion equations with mixed derivative terms High-order ADI schemes for convection-diffusion equations with mixed derivative terms B. Düring, M. Fournié and A. Rigal Abstract We consider new high-order Alternating Direction Implicit ADI) schemes

More information

Introduction to PDEs and Numerical Methods Tutorial 4. Finite difference methods stability, concsistency, convergence

Introduction to PDEs and Numerical Methods Tutorial 4. Finite difference methods stability, concsistency, convergence Platzhalter für Bild, Bild auf Titelfolie hinter das Logo einsetzen Introduction to PDEs and Numerical Methods Tutorial 4. Finite difference methods stability, concsistency, convergence Dr. Noemi Friedman,

More information

SOLVING ELLIPTIC PDES

SOLVING ELLIPTIC PDES university-logo SOLVING ELLIPTIC PDES School of Mathematics Semester 1 2008 OUTLINE 1 REVIEW 2 POISSON S EQUATION Equation and Boundary Conditions Solving the Model Problem 3 THE LINEAR ALGEBRA PROBLEM

More information

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

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

More information

Time-dependent variational forms

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

More information

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

2.3. Quantitative Properties of Finite Difference Schemes. Reading: Tannehill et al. Sections and

2.3. Quantitative Properties of Finite Difference Schemes. Reading: Tannehill et al. Sections and 3 Quantitative Properties of Finite Difference Schemes 31 Consistency, Convergence and Stability of FD schemes Reading: Tannehill et al Sections 333 and 334 Three important properties of FD schemes: Consistency

More information

Finite difference methods for the diffusion equation

Finite difference methods for the diffusion equation Finite difference methods for the diffusion equation D150, Tillämpade numeriska metoder II Olof Runborg May 0, 003 These notes summarize a part of the material in Chapter 13 of Iserles. They are based

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

Finite difference method for heat equation

Finite difference method for heat equation Finite difference method for heat equation 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

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

Part 1. The diffusion equation

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

More information

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

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

More information

Finite Difference Methods for Boundary Value Problems

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

More information

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

Lecture 4.5 Schemes for Parabolic Type Equations

Lecture 4.5 Schemes for Parabolic Type Equations Lecture 4.5 Schemes for Parabolic Type Equations 1 Difference Schemes for Parabolic Equations One-dimensional problems: Consider the unsteady diffusion problem (parabolic in nature) in a thin wire governed

More information

Finite Difference Methods (FDMs) 1

Finite Difference Methods (FDMs) 1 Finite Difference Methods (FDMs) 1 1 st - order Approxima9on Recall Taylor series expansion: Forward difference: Backward difference: Central difference: 2 nd - order Approxima9on Forward difference: Backward

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

Finite Difference Method

Finite Difference Method Capter 8 Finite Difference Metod 81 2nd order linear pde in two variables General 2nd order linear pde in two variables is given in te following form: L[u] = Au xx +2Bu xy +Cu yy +Du x +Eu y +Fu = G According

More information

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 28 PART II Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 29 BOUNDARY VALUE PROBLEMS (I) Solving a TWO

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

Numerical Solution of One-dimensional Advection-diffusion Equation Using Simultaneously Temporal and Spatial Weighted Parameters

Numerical Solution of One-dimensional Advection-diffusion Equation Using Simultaneously Temporal and Spatial Weighted Parameters Australian Journal of Basic and Applied Sciences, 5(6): 536-543, 0 ISSN 99-878 Numerical Solution of One-dimensional Advection-diffusion Equation Using Simultaneously Temporal and Spatial Weighted Parameters

More information

Numerical Analysis and Computer Science DN2255 Spring 2009 p. 1(8)

Numerical Analysis and Computer Science DN2255 Spring 2009 p. 1(8) Numerical Analysis and Computer Science DN2255 Spring 2009 p. 1(8) Contents Important concepts, definitions, etc...2 Exact solutions of some differential equations...3 Estimates of solutions to differential

More information

2 Multidimensional Hyperbolic Problemss where A(u) =f u (u) B(u) =g u (u): (7.1.1c) Multidimensional nite dierence schemes can be simple extensions of

2 Multidimensional Hyperbolic Problemss where A(u) =f u (u) B(u) =g u (u): (7.1.1c) Multidimensional nite dierence schemes can be simple extensions of Chapter 7 Multidimensional Hyperbolic Problems 7.1 Split and Unsplit Dierence Methods Our study of multidimensional parabolic problems in Chapter 5 has laid most of the groundwork for our present task

More information

FINITE DIFFERENCES. Lecture 1: (a) Operators (b) Forward Differences and their calculations. (c) Backward Differences and their calculations.

FINITE DIFFERENCES. Lecture 1: (a) Operators (b) Forward Differences and their calculations. (c) Backward Differences and their calculations. FINITE DIFFERENCES Lecture 1: (a) Operators (b) Forward Differences and their calculations. (c) Backward Differences and their calculations. 1. Introduction When a function is known explicitly, it is easy

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 A Model Problem in a 2D Box Region Let us consider a model problem of parabolic

More information

A CCD-ADI method for unsteady convection-diffusion equations

A CCD-ADI method for unsteady convection-diffusion equations A CCD-ADI method for unsteady convection-diffusion equations Hai-Wei Sun, Leonard Z. Li Department of Mathematics, University of Macau, Macao Abstract With a combined compact difference scheme for the

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

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

Lecture 17: Initial value problems

Lecture 17: Initial value problems Lecture 17: Initial value problems Let s start with initial value problems, and consider numerical solution to the simplest PDE we can think of u/ t + c u/ x = 0 (with u a scalar) for which the solution

More information

Introduction to Finite Di erence Methods

Introduction to Finite Di erence Methods Introduction to Finite Di erence Methods ME 448/548 Notes Gerald Recktenwald Portland State University Department of Mechanical Engineering gerry@pdx.edu ME 448/548: Introduction to Finite Di erence Approximation

More information

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

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

More information

q t = F q x. (1) is a flux of q due to diffusion. Although very complex parameterizations for F q

q t = F q x. (1) is a flux of q due to diffusion. Although very complex parameterizations for F q ! Revised Tuesday, December 8, 015! 1 Chapter 7: Diffusion Copyright 015, David A. Randall 7.1! Introduction Diffusion is a macroscopic statistical description of microscopic advection. Here microscopic

More information

The method of lines (MOL) for the diffusion equation

The method of lines (MOL) for the diffusion equation Chapter 1 The method of lines (MOL) for the diffusion equation The method of lines refers to an approximation of one or more partial differential equations with ordinary differential equations in just

More information

Partial Differential Equations

Partial Differential Equations Next: Using Matlab Up: Numerical Analysis for Chemical Previous: Ordinary Differential Equations Subsections Finite Difference: Elliptic Equations The Laplace Equations Solution Techniques Boundary Conditions

More information

Chapter 5 FINITE DIFFERENCE METHOD (FDM)

Chapter 5 FINITE DIFFERENCE METHOD (FDM) MEE7 Computer Modeling Tecniques in Engineering Capter 5 FINITE DIFFERENCE METHOD (FDM) 5. Introduction to FDM Te finite difference tecniques are based upon approximations wic permit replacing differential

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

1D Heat equation and a finite-difference solver

1D Heat equation and a finite-difference solver 1D Heat equation and a finite-difference solver Guillaume Riflet MARETEC IST 1 The advection-diffusion equation The original concept applied to a property within a control volume from which is derived

More information

Approximations of diffusions. Mathématiques appliquées (MATH0504-1) B. Dewals, Ch. Geuzaine

Approximations of diffusions. Mathématiques appliquées (MATH0504-1) B. Dewals, Ch. Geuzaine Lecture 3b Approximations of diffusions Mathématiques appliquées (MATH0504-1) B. Dewals, Ch. Geuzaine V1.1 04/10/2018 1 Learning objectives Become aware of the existence of stability conditions for the

More information

Partial Differential Equations

Partial Differential Equations Chapter 14 Partial Differential Equations Our intuition for ordinary differential equations generally stems from the time evolution of physical systems. Equations like Newton s second law determining the

More information

Numerical Solutions of the Burgers System in Two Dimensions under Varied Initial and Boundary Conditions

Numerical Solutions of the Burgers System in Two Dimensions under Varied Initial and Boundary Conditions Applied Mathematical Sciences, Vol. 6, 22, no. 3, 563-565 Numerical Solutions of the Burgers System in Two Dimensions under Varied Initial and Boundary Conditions M. C. Kweyu, W. A. Manyonge 2, A. Koross

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

Introduction to Heat and Mass Transfer. Week 9

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

More information

Chapter 5. Numerical Methods: Finite Differences

Chapter 5. Numerical Methods: Finite Differences Chapter 5 Numerical Methods: Finite Differences As you know, the differential equations that can be solved by an explicit analytic formula are few and far between. Consequently, the development of accurate

More information

Notes for Lecture 10

Notes for Lecture 10 February 2, 26 Notes for Lecture Introduction to grid-based methods for solving Poisson and Laplace Equations Finite difference methods The basis for most grid-based finite difference methods is the Taylor

More information

Numerical methods Revised March 2001

Numerical methods Revised March 2001 Revised March 00 By R. W. Riddaway (revised by M. Hortal) Table of contents. Some introductory ideas. Introduction. Classification of PDE's.3 Existence and uniqueness.4 Discretization.5 Convergence, consistency

More information

Numerical Solutions to PDE s

Numerical Solutions to PDE s Introduction Numerical Solutions to PDE s Mathematical Modelling Week 5 Kurt Bryan Let s start by recalling a simple numerical scheme for solving ODE s. Suppose we have an ODE u (t) = f(t, u(t)) for some

More information

Solution Methods. Steady State Diffusion Equation. Lecture 04

Solution Methods. Steady State Diffusion Equation. Lecture 04 Solution Methods Steady State Diffusion Equation Lecture 04 1 Solution methods Focus on finite volume method. Background of finite volume method. Discretization example. General solution method. Convergence.

More information

FINITE-VOLUME SOLUTION OF DIFFUSION EQUATION AND APPLICATION TO MODEL PROBLEMS

FINITE-VOLUME SOLUTION OF DIFFUSION EQUATION AND APPLICATION TO MODEL PROBLEMS IJRET: International Journal of Research in Engineering and Technology eissn: 39-63 pissn: 3-738 FINITE-VOLUME SOLUTION OF DIFFUSION EQUATION AND APPLICATION TO MODEL PROBLEMS Asish Mitra Reviewer: Heat

More information

FDM for wave equations

FDM for wave equations FDM for wave equations Consider the second order wave equation Some properties Existence & Uniqueness Wave speed finite!!! Dependence region Analytical solution in 1D Finite difference discretization Finite

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

An Exponential High-Order Compact ADI Method for 3D Unsteady Convection Diffusion Problems

An Exponential High-Order Compact ADI Method for 3D Unsteady Convection Diffusion Problems An Exponential High-Order Compact ADI Method for 3D Unsteady Convection Diffusion Problems Yongbin Ge, 1 Zhen F. Tian, 2 Jun Zhang 3 1 Institute of Applied Mathematics and Mechanics, Ningxia University,

More information

Scientific Computing II

Scientific Computing II Scientific Computing II Molecular Dynamics Numerics Michael Bader SCCS Technical University of Munich Summer 018 Recall: Molecular Dynamics System of ODEs resulting force acting on a molecule: F i = j

More information

Numerical Analysis of Differential Equations Numerical Solution of Elliptic Boundary Value

Numerical Analysis of Differential Equations Numerical Solution of Elliptic Boundary Value Numerical Analysis of Differential Equations 188 5 Numerical Solution of Elliptic Boundary Value Problems 5 Numerical Solution of Elliptic Boundary Value Problems TU Bergakademie Freiberg, SS 2012 Numerical

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

The Finite Difference Method

The Finite Difference Method The Finite Difference Method Heiner Igel Department of Earth and Environmental Sciences Ludwig-Maximilians-University Munich Heiner Igel Computational Seismology 1 / 32 Outline 1 Introduction Motivation

More information

x n+1 = x n f(x n) f (x n ), n 0.

x n+1 = x n f(x n) f (x n ), n 0. 1. Nonlinear Equations Given scalar equation, f(x) = 0, (a) Describe I) Newtons Method, II) Secant Method for approximating the solution. (b) State sufficient conditions for Newton and Secant to converge.

More information

10.34 Numerical Methods Applied to Chemical Engineering. Quiz 2

10.34 Numerical Methods Applied to Chemical Engineering. Quiz 2 10.34 Numerical Methods Applied to Chemical Engineering Quiz 2 This quiz consists of three problems worth 35, 35, and 30 points respectively. There are 4 pages in this quiz (including this cover page).

More information

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

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

More information

Practical in Numerical Astronomy, SS 2012 LECTURE 9

Practical in Numerical Astronomy, SS 2012 LECTURE 9 Practical in Numerical Astronomy, SS 01 Elliptic partial differential equations. Poisson solvers. LECTURE 9 1. Gravity force and the equations of hydrodynamics. Poisson equation versus Poisson integral.

More information

Chapter 10. Numerical Methods

Chapter 10. Numerical Methods Chapter 0 Numerical Methods As you know, most differential equations are far too complicated to be solved by an explicit analytic formula Thus, the development of accurate numerical approximation schemes

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

Math 5520 Homework 2 Solutions

Math 5520 Homework 2 Solutions Math 552 Homework 2 Solutions March, 26. Consider the function fx) = 2x ) 3 if x, 3x ) 2 if < x 2. Determine for which k there holds f H k, 2). Find D α f for α k. Solution. We show that k = 2. The formulas

More information

Problem Set 4 Issued: Wednesday, March 18, 2015 Due: Wednesday, April 8, 2015

Problem Set 4 Issued: Wednesday, March 18, 2015 Due: Wednesday, April 8, 2015 MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS 0139.9 NUMERICAL FLUID MECHANICS SPRING 015 Problem Set 4 Issued: Wednesday, March 18, 015 Due: Wednesday,

More information

THEODORE VORONOV DIFFERENTIABLE MANIFOLDS. Fall Last updated: November 26, (Under construction.)

THEODORE VORONOV DIFFERENTIABLE MANIFOLDS. Fall Last updated: November 26, (Under construction.) 4 Vector fields Last updated: November 26, 2009. (Under construction.) 4.1 Tangent vectors as derivations After we have introduced topological notions, we can come back to analysis on manifolds. Let M

More information

1 Finite difference example: 1D implicit heat equation

1 Finite difference example: 1D implicit heat equation 1 Finite difference example: 1D implicit heat equation 1.1 Boundary conditions Neumann and Dirichlet We solve the transient heat equation ρc p t = ( k ) (1) on the domain L/2 x L/2 subject to the following

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

Finite volume method for CFD

Finite volume method for CFD Finite volume method for CFD Indo-German Winter Academy-2007 Ankit Khandelwal B-tech III year, Civil Engineering IIT Roorkee Course #2 (Numerical methods and simulation of engineering Problems) Mentor:

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

Monte Carlo Method for Finding the Solution of Dirichlet Partial Differential Equations

Monte Carlo Method for Finding the Solution of Dirichlet Partial Differential Equations Applied Mathematical Sciences, Vol. 1, 2007, no. 10, 453-462 Monte Carlo Method for Finding the Solution of Dirichlet Partial Differential Equations Behrouz Fathi Vajargah Department of Mathematics Guilan

More information

Lecture 1. Finite difference and finite element methods. Partial differential equations (PDEs) Solving the heat equation numerically

Lecture 1. Finite difference and finite element methods. Partial differential equations (PDEs) Solving the heat equation numerically Finite difference and finite element methods Lecture 1 Scope of the course Analysis and implementation of numerical methods for pricing options. Models: Black-Scholes, stochastic volatility, exponential

More information

National Taiwan University

National Taiwan University National Taiwan University Meshless Methods for Scientific Computing (Advisor: C.S. Chen, D.L. oung) Final Project Department: Mechanical Engineering Student: Kai-Nung Cheng SID: D9956 Date: Jan. 8 The

More information