2.29 Numerical Fluid Mechanics Spring 2015 Lecture 13

Size: px
Start display at page:

Download "2.29 Numerical Fluid Mechanics Spring 2015 Lecture 13"

Transcription

1 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 using Roomberg s algorithm Fourier Error Analysis Provide additional information to truncation error: indicates how well Fourier mode solution, i.e. wavenumber and phase speed, is represented Effective wavenumber: e ikx i k e k k eff numerical k k k k eff ikx sin( k) nd (for CDS, 2 order, eff ) Effective wave speed (for linear convection eqn., f f c 0, integrating in time exactly): t num. dfk num. ikx ikeff t ik ( xceff t) ceff eff keff f ( t) c i k f ( x, t) f (0) e f (0) e dt c k (with i k c i k c ) eff eff eff PFJL Lecture 13, 1

2 REVIEW Lecture 12, Cont d: Stability Spring 2015 Lecture 13 Heuristic Method: trial and error n Energy Method: Find a quantity, l 2 norm 2, and then aim to show that it remains bounded for all n. Example: for c 0 t we obtained Von Neumann Method (Introduction), also called Fourier Analysis Method/Stability Hyperbolic PDEs and Stability ct nd order wave equation and waves on a string Characteristic finite-difference solution (review) ct Stability of C C (CDS in time/space, explicit): C 1 Example: Effective numerical wave numbers and dispersion PFJL Lecture 13, 2

3 FINITE DIFFERENCES Outline for Today Fourier Analysis and Error Analysis Differentiation, definition and smoothness of solution for order of spatial operators Stability Heuristic Method Energy Method Von Neumann Method (Introduction) : 1st order linear convection/wave eqn. Hyperbolic PDEs and Stability Example: 2nd order wave equation and waves on a string Effective numerical wave numbers and dispersion CFL condition: Definition Examples: 1st order linear convection/wave eqn., 2nd order wave eqn., other FD schemes Von Neumann examples: 1st order linear convection/wave eqn. Tables of schemes for 1st order linear convection/wave eqn. Elliptic PDEs FD schemes for 2D problems (Laplace, Poisson and Helmholtz eqns.) PFJL Lecture 13, 3

4 References and Reading Assignments Lapidus and Pinder, 1982: Numerical solutions of PDEs in Science and Engineering. Section 4.5 on Stability. Chapter 3 on Finite Difference Methods of J. H. Ferziger and M. Peric, Computational Methods for Fluid Dynamics. Springer, NY, 3 rd edition, 2002 Chapter 3 on Finite Difference Approximations of H. Lomax, T. H. Pulliam, D.W. Zingg, Fundamentals of Computational Fluid Dynamics (Scientific Computation). Springer, 2003 Chapter 29 and 30 on Finite Difference: Elliptic and Parabolic equations of Chapra and Canale, Numerical Methods for Engineers, 2014/2010/2006. PFJL Lecture 13, 4

5 Widely used procedure Von Neumann Stability Assumes initial error can be represented as a Fourier Series and considers growth or decay of these errors In theoretical sense, applies only to periodic BC problems and to linear problems Superposition of Fourier modes can then be used Again, use, ikx i x f ( x, t) fk ( t) e but for the error: ( x, t) ( t) e k Being interested in error growth/decay, consider only one mode: i x t i x ( t) e e e where is in general complex and function of : ( ) Strict Stability: The error will not to grow in time if t e 1 in other words, for t = nδt, the condition for strict stability can be written: e t t 1 or for e, 1 von Neumann condition Norm of amplification factor ξ smaller or equal to1 PFJL Lecture 13, 5

6 Evaluation of the Stability of a FD Scheme Von Neumann Example Consider again: c 0 t A possible FD formula ( upwind scheme) (t = nδt, x = Δx) which can be rewritten: n1 n n ct (1 ) 1 with x c t n1 n n n 1 Consider the Fourier error decomposition (one mode) and discretize it: (, ) ( ) i x t i x n x t t e e e e n t e i x Insert it in the FD scheme, assuming the error mode satisfies the FD (strictly valid for linear eq. only): (1 ) e e (1 ) e e e e n 1 n n ( n 1) t i x n t i x n t i ( 1) x 1 t 0-1 n+1 n x Cancel the common term (which is obtain: e (1 ) e t i e e n nt i ) in (linear) eq. and PFJL Lecture 13, 6

7 Evaluation of the Stability of a FD Scheme von Neumann Example The magnitude of complex conugate: Since t e is then obtained by multiplying ξ with its i i 2 i i e e (1 ) e (1 ) e 1 2 (1 ) 1 2 i i e e 2 cos( ) and 1 cos( ) 2sin ( ) 2 12 (1 ) 1 cos( ) 14 (1 )sin 2 ( ) 2 Thus, the strict von Neumann stability criterion gives (1 )sin ( ) 1 2 Since sin ( ) 0 1 cos( x) 0 2 we obtain the same result as for the energy method: c t c t 1 (1 ) ( ) Equivalent to the CFL condition PFJL Lecture 13, 7

8 Examples: Partial Differential Equations Hyperbolic PDE: B 2-4 A C > 0 (1) u 2 u c t (2) u u c 0 t (3) u ( U ) u g t (4) ( U) u g Wave equation, 2 nd order (from Lecture 10) Sommerfeld Wave/radiation equation, 1 st order Unsteady (linearized) inviscid convection (Wave equation first order) Steady (linearized) inviscid convection Allows non-smooth solutions Information travels along characteristics, e.g.: For (3) above: For (4), along streamlines: Domain of dependence of u(x,t) = characteristic path e.g., for (3), it is: x c (t) for 0< t < T Finite Differences, Finite Volumes and Finite Elements Upwind schemes d x dt c Ux ( ( t)) c d x c ds U t 0 x, y PFJL Lecture 13, 8

9 Waves on a String Partial Differential Equations Hyperbolic PDE - Example u( x, t) 2 u( x, t) c 0 x L, 0 t t Initial Conditions t (from Lecture 10) Boundary Conditions u0,t) ul,t) Wave Solutions u(x,0), u t (x,0) x Typically Initial Value Problems in Time, Boundary Value Problems in Space Time-Marching Solutions: Implicit schemes generally stable Explicit sometimes stable under certain conditions PFJL Lecture 13, 9

10 Wave Equation Partial Differential Equations Hyperbolic PDE - Example u( x, t) 2 u( x, t) c 0 x L, 0 t t t (from Lecture 10) Discretization: Finite Difference Representations (centered) u0,t) ul,t) +1-1 Finite Difference Representations i-1 i i+1 u(x,0), u t (x,0) x PFJL Lecture 13, 10

11 Partial Differential Equations Hyperbolic PDE - Example Introduce Dimensionless Wave Speed t (from Lecture 10) Explicit Finite Difference Scheme u0,t) ul,t) +1-1 Stability Requirement: ct C 1 Courant-Friedrichs-Lewy condition (CFL condition) i-1 i i+1 x u(x,0), u t (x,0) Physical wave speed must be smaller than the largest numerical wave speed, or, Time-step must be less than the time for the wave to travel to adacent grid points: PFJL Lecture 13, 11 c t or t c

12 Partial Differential Equations Hyperbolic PDE - Example Start of Integration: Euler and Higher Order Starters Given ICs: t 1 st order Euler Starter But, second derivative in x at t = 0 is known from IC: From Wave Equation u0,t) ul,t) Higher order Taylor Expansion +k Higher Order Self Starter =2-2 i-1 i i+1 u(x,0)=f(x), u t (x,0)=g(x) =1 x General idea: use the PDE itself to get higher order integration PFJL Lecture 13, 12

13 Waves on a String u( x, t) 2 u( x, t) c 0 x L, 0 t t Initial condition L=10; T=10; waveeq.m c=1.5; N=100; h=l/n; M=400; k=t/m; C=c*k/h Lf=0.5; x=[0:h:l]'; t=[0:k:t]; %fx=['exp(-0.5*(' num2str(l/2) '-x).^2/(' num2str(lf) ').^2)']; %gx='0'; fx='exp(-0.5*(5-x).^2/0.5^2).*cos((x-5)*pi)'; gx='0'; %Zero first time derivative at t=0 f=inline(fx,'x'); g=inline(gx,'x'); n=length(x); m=length(t); u=zeros(n,m); % Second order starter u(2:n-1,1)=f(x(2:n-1)); for i=2:n-1 u(i,2) = (1-C^2)*u(i,1) + k*g(x(i)) +C^2*(u(i-1,1)+u(i+1,1))/2; end % CDS: Iteration in time () and space (i) for =2:m-1 for i=2:n-1 u(i,+1)=(2-2*c^2)*u(i,) + C^2*(u(i+1,)+u(i-1,)) - u(i,-1); end end figure(1) plot(x,f(x)); a=title(['fx = ' fx]); set(a,'fontsize',16); figure(2) wavei(u',x,t); a=xlabel('x'); set(a,'fontsize',14); a=ylabel('t'); set(a,'fontsize',14); a=title('waves on String'); set(a,'fontsize',16); colormap; PFJL Lecture 13, 13

14 Waves on a String, Longer simulation: Effects of dispersion and effective wavenumber/speed L=10; T=10; waveeq.m c=1.5; N=100; h=l/n; % Horizontal resolution (Dx) M=400; % Test: increase duration of simulation, to see effect of %dispersion and effective wavenumber/speed (due to 2 nd order) %T=100;M=4000; k=t/m; % Time resolution (Dt) C=c*k/h % Try case C>1, e.g. decrease Dx or increase Dt Lf=0.5; x=[0:h:l]'; t=[0:k:t]; %fx=['exp(-0.5*(' num2str(l/2) '-x).^2/(' num2str(lf) ').^2)']; %gx='0'; fx='exp(-0.5*(5-x).^2/0.5^2).*cos((x-5)*pi)'; gx='0'; f=inline(fx,'x'); g=inline(gx,'x'); n=length(x); m=length(t); u=zeros(n,m); %Second order starter u(2:n-1,1)=f(x(2:n-1)); for i=2:n-1 u(i,2) = (1-C^2)*u(i,1) + k*g(x(i)) +C^2*(u(i-1,1)+u(i+1,1))/2; end %CDS: Iteration in time () and space (i) for =2:m-1 for i=2:n-1 u(i,+1)=(2-2*c^2)*u(i,) + C^2*(u(i+1,)+u(i-1,)) - u(i,-1); end end PFJL Lecture 13, 14

15 Wave Equation d Alembert s Solution Wave Equation u( x, t) 2 u( x, t) c t 0 x L, 0 t Solution t Periodicity Properties F u0,t) G F ul,t) Proof u(x,0)=f(x), u t (x,0)=g(x) x PFJL Lecture 13, 15

16 Hyperbolic PDE Method of Characteristics Explicit Finite Difference Scheme t First 2 Rows known u0,t) G F ul,t) +1-1 Characteristic Sampling Exact Discrete Solution u(x,0)=f(x), u t (x,0)=g(x) x PFJL Lecture 13, 16

17 Hyperbolic PDE Method of Characteristics Let s proof the following FD scheme is an exact Discrete Solution D Alembert s Solution with C=1 t u0,t) ul,t) G F +1-1 Proof u(x,0)=f(x), u t (x,0)=g(x) x PFJL Lecture 13, 17

18 Courant-Fredrichs-Lewy Condition (1920 s) Basic idea: the solution of the Finite-Difference (FD) equation can not be independent of the (past) information that determines the solution of the corresponding PDE In other words: The Numerical domain of dependence of FD scheme must include the mathematical domain of dependence of the corresponding PDE time CFL NOT satisfied time CFL satisfied uxt (,) uxt (,) PDE dependence Numerical stencil space space PFJL Lecture 13, 18

19 Determine domain of dependence of PDE and of FD scheme PDE: FD scheme. For our Upwind discretization, with t = nδt, x = Δx : => CFL condition: CFL: Linear convection (Sommerfeld Eqn) Example u( x, t) u( x, t) c t 0 Solution of the form: u( x, t) F( x ct) dt 1 Slope of characteristic: dx c t Slope of Upwind scheme: ct 1 t 1 c dx Characteristics: If c x c t and du 0 u cst dt c t n1 n n n 1 True solution is outside of numerical domain of influence 0 CFL NOT satisfied -1 CFL satisfied n+1 n True solution is within numerical domain of influence Springer. All rights reserved. This content is excluded from our Creative Commons license. For more information, see Source: Figure 2.1 from Durran, D. Numerical Methods for Wave Equations in Geophysical Fluid Dynamics. Springer, PFJL Lecture 13, 19

20 CFL: 2 nd order Wave equation Example Determine domain of dependence of PDE and of FD scheme PDE, second order wave eqn example: u( x, t) 2 u( x, t) c 0 x L, 0 t t As seen before: u( x, t) F( x ct) G( x ct) slope of characteristics: FD scheme: discretize: t = nδt, x = Δx dt dx 1 c CD scheme (CDS) in time and space (2nd order), explicit n1 n n1 n n n u 2u u 2 u 1 2u u 1 n1 2 n 2 n n n1 ct c u ( ) ( C u C u 1 u 1) u where C= t We obtain from the respective slopes: t ct 1 Full line case: CFL satisfied Dotted lines case: c and Δt too big, Δx too small (CFL NOT satisfied) n x PFJL Lecture 13, 20

21 CFL Condition: Some comments CFL is only a necessary condition for stability Other (sufficient) stability conditions are often more restrictive u( x, t) u( x, t) t For example: if c 0 is discretized as u( x, t) u( x, t) c t nd One obtains from the CFL: CD,2 order in t CD,4 order in x ct 2 While a Von Neumann analysis leads: th ct Five grid-points stencil: (-1,8,0,-8,1) / 12 See Taylor tables in previous lecture and eqn. sheet For equations that are not purely hyperbolic or that can change of type (e.g. as diffusion term increases), CFL condition can at times be violated locally for a short time, without leading to global instability further in time PFJL Lecture 13, 21

22 von Neumann Examples Forward in time (Euler), centered in space, Explicit n1 n n n 1 1 n1 n C n n c 0 ( 1 1) t 2 2 Von Neumann: insert n1 n C n n t C i i ( 1 1) e 1 e e 1 Ci sin( ) Taking the norm: Unconditionally Unstable Implicit scheme (backward in time, centered in space) Unconditionally Stable ( x, t) ( t) e e e e e i x t i x n n t i t e 1 Ci sin( ) 1 Ci sin( ) 1 C sin ( ) 1 for C 0! n1 n n1 n1 1 1 n1 n C n1 n1 t t c 0 ( 1 1) e 1 e Ci sin( ) t 2 2 t 1 1 e 1 for C 0! 1 Ci sin( ) 1 Ci sin( ) 1 C sin ( ) PFJL Lecture 13, 22

23 Stability of FD schemes for u t + b u y = 0 (t denoted x below) Table showing various finite difference forms removed due to copyright restrictions. Please see Table 6.1 in Lapidus, L., and G. Pinder. Numerical Solution of Partial Differential Equations in Science and Engineering. Wiley-Interscience, PFJL Lecture 13, 23

24 Stability of FD schemes for u t + b u y = 0, Cont. Table showing various finite difference forms removed due to copyright restrictions. Please see Table 6.1 in Lapidus, L., and G. Pinder. Numerical Solution of Partial Differential Equations in Science and Engineering. Wiley-Interscience, PFJL Lecture 13, 24

25 Partial Differential Equations Elliptic PDE (from Lecture 9) Laplace Operator Examples: ϕ ϕ Laplace Equation Potential Flow Poisson Equation Potential Flow with sources Steady heat conduction in plate + source 2 Uu u Helmholtz equation Vibration of plates Steady Convection-Diffusion Smooth solutions ( diffusion effect ) Very often, steady state problems Domain of dependence of u is the full domain D(x,y) => global solutions Finite differ./volumes/elements, boundary integral methods (Panel methods) PFJL Lecture 13, 25

26 Partial Differential Equations Elliptic PDE - Example (from Lecture 9) y Equidistant Sampling u(x,b) = f 2 (x) Discretization Finite Differences u0,y)=g 1 (y) ua,y)=g 2 (y) +1-1 i-1 i i+1 u(x,0) = f 1 (x) x Dirichlet BC PFJL Lecture 13, 26

27 Partial Differential Equations Elliptic PDE - Example (from Lecture 9) Discretized Laplace Equation y Finite Difference Scheme u(x,b) = f 2 (x) Boundary Conditions i u0,y)=g 1 (y) ua,y)=g 2 (y) +1-1 i Global Solution Required i-1 i i+1 u(x,0) = f 1 (x) x PFJL Lecture 13, 27

28 Elliptic PDEs Laplace Equation, Global Solvers p 7 p 8 p 9 p 4 p 5 p 6 Dirichlet BC Leads to Ax = b, with A block-tridiagonal: A = tri { I, T, I } u 1,2 p 1 p 2 p 3 u 5,2 u 2,1 u 5,2 PFJL Lecture 13, 28

29 Ellipticic PDEs Neumann Boundary Conditions Neumann (Derivative) Boundary Condition given Finite Difference Scheme at i = n y Finite Difference Scheme u(x,b) = f 2 (x) Derivative BC: Finite Difference u0,y)=g 1 (y) u x a,y) given Boundary Finite Difference Scheme at i = n u un 1, 2 un 1, un, 1 un, 1 4un, 0 n i-1 i i+1 u(x,0) = f 1 (x) Leads to a factor 2 (a matrix 2 I in A) for points along boundary x PFJL Lecture 13, 29

30 MIT OpenCourseWare Spring 2015 For information about citing these materials or our Terms of Use, visit:

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.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

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

Numerical Marine Hydrodynamics Summary

Numerical Marine Hydrodynamics Summary Numerical Marine Hydrodynamics Summary Fundamentals of Digital Computing Error Analysis Roots of Non-linear Equations Systems of Linear Equations Gaussian Elimination Iterative Methods Optimization, Curve

More information

2.29 Numerical Fluid Mechanics Fall 2009 Lecture 13

2.29 Numerical Fluid Mechanics Fall 2009 Lecture 13 2.29 Numerical Fluid Mechanics Fall 2009 Lecture 13 REVIEW Lecture 12: Classification of Partial Differential Equations (PDEs) and eamples with finite difference discretizations Parabolic PDEs Elliptic

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

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 20

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 20 2.29 Numerical Fluid Mechanics Fall 2011 Lecture 20 REVIEW Lecture 19: Finite Volume Methods Review: Basic elements of a FV scheme and steps to step-up a FV scheme One Dimensional examples d x j x j 1/2

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

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

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

PDEs, part 3: Hyperbolic PDEs

PDEs, part 3: Hyperbolic PDEs PDEs, part 3: Hyperbolic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2011 Hyperbolic equations (Sections 6.4 and 6.5 of Strang). Consider the model problem (the

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

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

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

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

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

Applied Mathematics 205. Unit III: Numerical Calculus. Lecturer: Dr. David Knezevic

Applied Mathematics 205. Unit III: Numerical Calculus. Lecturer: Dr. David Knezevic Applied Mathematics 205 Unit III: Numerical Calculus Lecturer: Dr. David Knezevic Unit III: Numerical Calculus Chapter III.3: Boundary Value Problems and PDEs 2 / 96 ODE Boundary Value Problems 3 / 96

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

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 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

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

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 21

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 21 Spring 2015 Lecture 21 REVIEW Lecture 20: Time-Marching Methods and ODEs IVPs Time-Marching Methods and ODEs Initial Value Problems Euler s method Taylor Series Methods Error analysis: for two time-levels,

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 and Its Difference Approximations 1-D Initial Boundary Value

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

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

Direct Methods for solving Linear Equation Systems

Direct Methods for solving Linear Equation Systems REVIEW Lecture 5: Systems of Linear Equations Spring 2015 Lecture 6 Direct Methods for solving Linear Equation Systems Determinants and Cramer s Rule Gauss Elimination Algorithm Forward Elimination/Reduction

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

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

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

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

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

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 27

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 27 REVIEW Lecture 26: Fall 2011 Lecture 27 Solution of the Navier-Stokes Equations Pressure Correction and Projection Methods (review) Fractional Step Methods (Example using Crank-Nicholson) Streamfunction-Vorticity

More information

Chapter 5 Types of Governing Equations. Chapter 5: Governing Equations

Chapter 5 Types of Governing Equations. Chapter 5: Governing Equations Chapter 5 Types of Governing Equations Types of Governing Equations (1) Physical Classification-1 Equilibrium problems: (1) They are problems in which a solution of a given PDE is desired in a closed domain

More information

Finite Volume Method

Finite Volume Method Finite Volume Method An Introduction Praveen. C CTFD Division National Aerospace Laboratories Bangalore 560 037 email: praveen@cfdlab.net April 7, 2006 Praveen. C (CTFD, NAL) FVM CMMACS 1 / 65 Outline

More information

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

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

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

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

Numerical Methods for PDEs

Numerical Methods for PDEs Numerical Methods for PDEs Problems 1. Numerical Differentiation. Find the best approximation to the second drivative d 2 f(x)/dx 2 at x = x you can of a function f(x) using (a) the Taylor series approach

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

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

3.3. Phase and Amplitude Errors of 1-D Advection Equation

3.3. Phase and Amplitude Errors of 1-D Advection Equation 3.3. Phase and Amplitude Errors of 1-D Advection Equation Reading: Duran section 2.4.2. Tannehill et al section 4.1.2. The following example F.D. solutions of a 1D advection equation show errors in both

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

AM 205: lecture 14. Last time: Boundary value problems Today: Numerical solution of PDEs

AM 205: lecture 14. Last time: Boundary value problems Today: Numerical solution of PDEs AM 205: lecture 14 Last time: Boundary value problems Today: Numerical solution of PDEs ODE BVPs A more general approach is to formulate a coupled system of equations for the BVP based on a finite difference

More information

Lecture 21: The one dimensional Wave Equation: D Alembert s Solution

Lecture 21: The one dimensional Wave Equation: D Alembert s Solution Introductory lecture notes on Partial Differential Equations - c Anthony Peirce. Not to be copied, used, or revised without explicit written permission from the copyright owner. 1 Lecture 21: The one dimensional

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

1 Introduction to MATLAB

1 Introduction to MATLAB L3 - December 015 Solving PDEs numerically (Reports due Thursday Dec 3rd, carolinemuller13@gmail.com) In this project, we will see various methods for solving Partial Differential Equations (PDEs) using

More information

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

Module 3: BASICS OF CFD. Part A: Finite Difference Methods Module 3: BASICS OF CFD Part A: Finite Difference Methods THE CFD APPROACH Assembling the governing equations Identifying flow domain and boundary conditions Geometrical discretization of flow domain Discretization

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

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

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 4

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 4 2.29 Spring 2015 Lecture 4 Review Lecture 3 Truncation Errors, Taylor Series and Error Analysis Taylor series: 2 3 n n i1 i i i i i n f( ) f( ) f '( ) f ''( ) f '''( )... f ( ) R 2! 3! n! n1 ( n1) Rn f

More information

Chapter 10 Exercises

Chapter 10 Exercises Chapter 10 Exercises From: Finite Difference Methods for Ordinary and Partial Differential Equations by R. J. LeVeque, SIAM, 2007. http://www.amath.washington.edu/ rl/fdmbook Exercise 10.1 (One-sided and

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

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

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

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

Method of Lines. Received April 20, 2009; accepted July 9, 2009

Method of Lines. Received April 20, 2009; accepted July 9, 2009 Method of Lines Samir Hamdi, William E. Schiesser and Graham W. Griffiths * Ecole Polytechnique, France; Lehigh University, USA; City University,UK. Received April 20, 2009; accepted July 9, 2009 The method

More information

7 Hyperbolic Differential Equations

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

More information

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

Advection / Hyperbolic PDEs. PHY 604: Computational Methods in Physics and Astrophysics II

Advection / Hyperbolic PDEs. PHY 604: Computational Methods in Physics and Astrophysics II Advection / Hyperbolic PDEs Notes In addition to the slides and code examples, my notes on PDEs with the finite-volume method are up online: https://github.com/open-astrophysics-bookshelf/numerical_exercises

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

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

Numerical Analysis of Differential Equations Numerical Solution of Parabolic Equations

Numerical Analysis of Differential Equations Numerical Solution of Parabolic Equations Numerical Analysis of Differential Equations 215 6 Numerical Solution of Parabolic Equations 6 Numerical Solution of Parabolic Equations TU Bergakademie Freiberg, SS 2012 Numerical Analysis of Differential

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

arxiv: v1 [physics.comp-ph] 22 Feb 2013

arxiv: v1 [physics.comp-ph] 22 Feb 2013 Numerical Methods and Causality in Physics Muhammad Adeel Ajaib 1 University of Delaware, Newark, DE 19716, USA arxiv:1302.5601v1 [physics.comp-ph] 22 Feb 2013 Abstract We discuss physical implications

More information

Acoustic Wave Equation

Acoustic Wave Equation Acoustic Wave Equation Sjoerd de Ridder (most of the slides) & Biondo Biondi January 16 th 2011 Table of Topics Basic Acoustic Equations Wave Equation Finite Differences Finite Difference Solution Pseudospectral

More information

7 EQUATIONS OF MOTION FOR AN INVISCID FLUID

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

More information

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

ECE257 Numerical Methods and Scientific Computing. Ordinary Differential Equations

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

More information

Before we look at numerical methods, it is important to understand the types of equations we will be dealing with.

Before we look at numerical methods, it is important to understand the types of equations we will be dealing with. Chapter 1. Partial Differential Equations (PDEs) Required Readings: Chapter of Tannehill et al (text book) Chapter 1 of Lapidus and Pinder (Numerical Solution of Partial Differential Equations in Science

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

Introduction of Partial Differential Equations and Boundary Value Problems

Introduction of Partial Differential Equations and Boundary Value Problems Introduction of Partial Differential Equations and Boundary Value Problems 2009 Outline Definition Classification Where PDEs come from? Well-posed problem, solutions Initial Conditions and Boundary Conditions

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

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

Introduction to PDEs and Numerical Methods: Exam 1

Introduction to PDEs and Numerical Methods: Exam 1 Prof Dr Thomas Sonar, Institute of Analysis Winter Semester 2003/4 17122003 Introduction to PDEs and Numerical Methods: Exam 1 To obtain full points explain your solutions thoroughly and self-consistently

More information

difference operators.

difference operators. 2D1263 : Scientific Computing Lecture 8 (2) 2D1263 : Scientific Computing Lecture 8 (1) Difference operators Let xi m i=0 be equidistant points in [a, b], x i = a + (b a)i/m, and define the forward difference

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

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

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

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Introduction to Hyperbolic Equations The Hyperbolic Equations n-d 1st Order Linear

More information

MITOCW ocw feb k

MITOCW ocw feb k MITOCW ocw-18-086-13feb2006-220k INTRODUCTION: The following content is provided by MIT OpenCourseWare under a Creative Commons license. Additional information about our license and MIT OpenCourseWare

More information

Module 1: Introduction to Finite Difference Method and Fundamentals of CFD Lecture 1: Finite Difference Method

Module 1: Introduction to Finite Difference Method and Fundamentals of CFD Lecture 1: Finite Difference Method file:///d:/chitra/nptel_phase2/mechanical/cfd/lecture1/1_1.htm 1 of 1 6/19/2012 4:29 PM The Lecture deals with: Classification of Partial Differential Equations Boundary and Initial Conditions Finite Differences

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

A local Crank-Nicolson method for solving the heat equation. Abdurishit ABUDUWALI, Michio SAKAKIHARA and Hiroshi NIKI

A local Crank-Nicolson method for solving the heat equation. Abdurishit ABUDUWALI, Michio SAKAKIHARA and Hiroshi NIKI HIROSHIMA MATH. J. 24 (1994), 1-13 A local Crank-Nicolson method for solving the heat equation Abdurishit ABUDUWALI, Michio SAKAKIHARA and Hiroshi NIKI (Received February 6, 1992) 1. Introduction du A

More information

UNIVERSITY of LIMERICK OLLSCOIL LUIMNIGH

UNIVERSITY of LIMERICK OLLSCOIL LUIMNIGH UNIVERSITY of LIMERICK OLLSCOIL LUIMNIGH Faculty of Science and Engineering Department of Mathematics and Statistics END OF SEMESTER ASSESSMENT PAPER MODULE CODE: MA4006 SEMESTER: Spring 2011 MODULE TITLE:

More information

Numerical Methods for PDEs

Numerical Methods for PDEs Numerical Methods for PDEs Partial Differential Equations (Lecture 1, Week 1) Markus Schmuck Department of Mathematics and Maxwell Institute for Mathematical Sciences Heriot-Watt University, Edinburgh

More information

Boundary-value Problems in Rectangular Coordinates

Boundary-value Problems in Rectangular Coordinates Boundary-value Problems in Rectangular Coordinates 2009 Outline Separation of Variables: Heat Equation on a Slab Separation of Variables: Vibrating String Separation of Variables: Laplace Equation Review

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

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 The Implicit Schemes for the Model Problem The Crank-Nicolson scheme and θ-scheme

More information

Chapter 3 Second Order Linear Equations

Chapter 3 Second Order Linear Equations Partial Differential Equations (Math 3303) A Ë@ Õæ Aë áöß @. X. @ 2015-2014 ú GA JË@ É Ë@ Chapter 3 Second Order Linear Equations Second-order partial differential equations for an known function u(x,

More information

The Euler Equation of Gas-Dynamics

The Euler Equation of Gas-Dynamics The Euler Equation of Gas-Dynamics A. Mignone October 24, 217 In this lecture we study some properties of the Euler equations of gasdynamics, + (u) = ( ) u + u u + p = a p + u p + γp u = where, p and u

More information

Lecture 6: Introduction to Partial Differential Equations

Lecture 6: Introduction to Partial Differential Equations Introductory lecture notes on Partial Differential Equations - c Anthony Peirce. Not to be copied, used, or revised without explicit written permission from the copyright owner. 1 Lecture 6: Introduction

More information

Evolution equations with spectral methods: the case of the wave equation

Evolution equations with spectral methods: the case of the wave equation Evolution equations with spectral methods: the case of the wave equation Jerome.Novak@obspm.fr Laboratoire de l Univers et de ses Théories (LUTH) CNRS / Observatoire de Paris, France in collaboration with

More information

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

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

More information

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Xu Chen Assistant Professor United Technologies Engineering Build, Rm. 382 Department of Mechanical Engineering University of Connecticut xchen@engr.uconn.edu Contents 1

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

Finite difference method for elliptic problems: I

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

More information

Introduction to Seismology Spring 2008

Introduction to Seismology Spring 2008 MIT OpenCourseWare http://ocw.mit.edu 12.510 Introduction to Seismology Spring 2008 For information about citing these materials or our Terms of Use, visit: http://ocw.mit.edu/terms. 12.510 Introduction

More information