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

Size: px
Start display at page:

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

Transcription

1 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 finite-difference solution Stability of C C (CDS in time/space, explicit): Example: Effective numerical wave numbers and dispersion CFL condition: Numerical domain of dependence must include Mathematical domain of dependence Examples: 1st order linear convection/wave eqn., nd order wave eqn. Other FD schemes (C nd C 4 th ) Von Neumann: 1 st order linear convection/wave eqn., F- C: unstable Stability summary: Tables of schemes for 1 st order linear convection/wave eqn. Elliptic PDEs FD schemes for D problems (Laplace, Poisson and Helmholtz eqns.) Direct nd order and Iterative (Jacobi, Gauss-Seidel) Boundary conditions ct C 1 x ct C 1 x PFJL Lecture 14, 1

2 Elliptic PDEs, Continued TODAY (Lecture 14): FINITE DIFFERENCES, Cont d Examples, Higher order finite differences Irregular boundaries: Dirichlet and Von Neumann BCs Internal boundaries Parabolic PDEs and Stability Explicit schemes (1D-space) Von Neumann Implicit schemes (1D-space): simple and Crank-Nicholson Von Neumann Examples Extensions to D and 3D Explicit and Implicit schemes Alternating-Direction Implicit (ADI) schemes PFJL Lecture 14,

3 TODAY (Lecture 14, Cont d): FINITE VOLUME METHODS Integral forms of the conservation laws Introduction to FV Methods Approximations needed and basic elements of a FV scheme FV grids Approximation of surface integrals (leading to symbolic formulas) Approximation of volume integrals (leading to symbolic formulas) Summary: Steps to step-up FV scheme Examples: One Dimensional examples Generic equations Linear Convection (Sommerfeld eqn.): convective fluxes nd order in space, 4 th order in space, links to CDS Unsteady Diffusion equation: diffusive fluxes Two approaches for nd order in space, links to CDS PFJL Lecture 14, 3

4 References and Reading Assignments Lapidus and Pinder, 198: 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, 00 Chapter 3 on Finite Difference Approximations of H. Lomax, T. H. Pulliam, D.W. Zingg, Fundamentals of Computational Fluid Dynamics (Scientific Computation). Springer, 003 Chapter 9 and 30 on Finite Difference: Elliptic and Parabolic equations of Chapra and Canale, Numerical Methods for Engineers, 014/010/006. PFJL Lecture 14, 4

5 Elliptic PDEs Iterative Schemes: Laplace equation Finite Difference Scheme u u u u u k k k k k 1 i1, i1, i, 1 i, 1 4 i, 0 Liebman Iterative Scheme (Jacobi/Gauss-Seidel) k1 u u u u ui, 4 u x k k k k i1, i1, i, 1 i, 1 u y 0 r k i, u u u u 4u 4 k k k k k i1, i1, i, 1 i, 1 i, SOR Iterative Scheme, Jacobi y u(x,b) = f (x) k u u u u 4u ui, 4 k k k k k u u u u (1 ) ui, 4 Optimal SOR (Equidistant Sampling h) k k k k k i 1, i 1, i, 1 i, 1 i, i1, i1, i, 1 i, 1 u(0,y)=g 1 (y) u(a,y)=g (y) +1-1 i-1 i i+1 u(x,0) = f 1 (x) x PFJL Lecture 14, 5

6 Elliptic PDE: Poisson Equation SOR Iterative Scheme, with Jacobi k u u u u 4u h g ui, 4 k u u u u h g (1 ) ui, 4 k k k k k i1, i1, i, 1 i, 1 i, i, k k k k i1, i1, i, 1 i, 1 i, PFJL Lecture 14, 6

7 Elliptic PDE: Poisson Equation SOR Iterative Scheme, with Gauss-Seidel k u u u u 4u h g ui, 4 k u u u u h g (1 ) ui, 4 k k+1 k k+1 k i1, i1, i, 1 i, 1 i, i, k k+1 k k+1 i1, i1, i, 1 i, 1 i, PFJL Lecture 14, 7

8 Laplace Equation Steady Heat diffusion (with source: Poisson eqn) Lx=1; Ly=1; N=10; h=lx/n; M=floor(Ly/Lx*N); niter=0; eps=1e-6; x=[0:h:lx]'; y=[0:h:ly]; f1x='4*x-4*x.^'; %f1x='0' fx='0'; g1x='0'; gx='0'; gxy='0'; f1=inline(f1x,'x'); f=inline(fx,'x'); g1=inline(g1x,'y'); g=inline(gx,'y'); gf=inline(gxy,'x','y'); n=length(x); m=length(y); u=zeros(n,m); u(:n-1,1)=f1(x(:n-1)); u(:n-1,m)=f(x(:n-1)); u(1,1:m)=g1(y); u(n,1:m)=g(y); for i=1:n for =1:m g(i,) = gf(x(i),y()); end end duct.m u_0=mean(u(1,:))+mean(u(n,:))+mean(u(:,1))+mean(u(:,m)); u(:n-1,:m-1)=u_0*ones(n-,m-); omega=4/(+sqrt(4-(cos(pi/(n-1))+cos(pi/(m-1)))^)) for k=1:niter u_old=u; for i=:n-1 for =:m-1 u(i,)=(1-omega)*u(i,) +omega*(u(i-1,)+u(i+1,)+u(i,-1)+u(i,+1)-h^*g(i,))/4; end end r=abs(u-u_old)/max(max(abs(u))); k,r if (max(max(r))<eps) break; end end figure(3) surf(y,x,u); shading interp; a=ylabel('x'); set(a,'fontsize',14); a=xlabel('y'); set(a,'fontsize',14); a=title(['poisson Equation - g = ' gxy]); set(a,'fontsize',16); u u gxy (, ) x y BCs : u ( x,0, t) f ( x) 4x 4x Three other BCs are null PFJL Lecture 14, 8

9 Helmholtz Equation SOR Iterative Scheme, with Gauss-Seidel u k k +1 k k +1 k k ui 1, ui 1, ui, 1 ui, 1 (4 h fi, ) ui, h gi, i, (4 h fi, ) (1 ) u k k +1 k k+1 k ui 1, ui 1, ui, 1 ui, 1 h gi, i, (4 h fi, ) PFJL Lecture 14, 9

10 Elliptic PDE s Higher Order Finite Differences CD, 4 th order (see tables in eqs. sheet) y u 16 u 30 u 16 u u k k k k k u i, i1, i, i1, i, x th 1h CD, 4 order u(x,b) = f (x) The resulting 9 point cross stencil (not drawn) is more challenging computationally (boundary, etc) than CD nd order. u(0,y)=g 1 (y) Use more compact scheme instead u(a,y)=g (y) +1-1 Square stencil (see figure): Use Taylor series, then cancel the terms so as to get a 4 th order scheme i-1 i i+1 u(x,0) = f 1 (x) x Leads to: + PFJL Lecture 14, 10

11 Elliptic PDEs: Irregular Boundaries Many elliptic problems don t have simple boundaries/geometries One way to handle them is through irregular discrete boundary cells (e.g. shaved cells) 1) Boundary Stencils (with Dirichlet BCs) i-1, α 1 x β y α x 1 st derivatives evaluated at center of edges, hence dx is sum of half edge lengths on each side i-1, i y, x, i i, -1 β 1 y Image of a grid for a heated plate that has an irregularly shaped boundary. Image by MIT OpenCourseWare. Can be used directly with Dirichlet BCs Leads to direct and iterative elliptic solvers as before, but with updated coefficients for the boundary stencils Other options possible: curved boundary elements PFJL Lecture 14, 11

12 Elliptic PDEs: Irregular Boundaries ) Neumann Boundary Conditions (e.g. normal derivative given) 3 θ y 7 Linear interpolation at 7 6 x Curved boundary in which the normal gradient is specified. Image by MIT OpenCourseWare. 5 This is an approach given in Chapra & Canale One may instead estimate u 3 from neighbor nodes, then take the derivative along 1-3 PFJL Lecture 14, 1

13 Elliptic PDEs Internal (Fixed) Boundaries Velocity and Stress Continuity (heat flux or viscous stress) Derivative Finite Differences (1 st order) McGraw-Hill. All rights reserved. This content is excluded fromourcreativecommons license. For more information, seehttp://ocw.mit.edu/fairuse. Source: Chapra, S. and R. Canale. Numerical Methods for Engineers.McGraw-Hill, 005. y Finite Difference Equation at bnd. i, SOR Finite Difference Scheme at bnd i, i, i-1 i i+1 x PFJL Lecture 14, 13

14 Elliptic PDEs Internal (Fixed) Boundaries Higher Order Velocity and Stress Continuity Taylor Series, inserting the PDE u u f ( x, y) f ( x, y), g ( x, y) x y y g i, xx g i, Derivative Finite Differences ( nd order) xx +1-1 g i, Finite Difference Equation at bnd. SOR Finite Difference Scheme at bnd. g i, g i, g i, g g i-1 i i+1 McGraw-Hill. All rights reserved. This content is excluded from our Creative Commons license. For more information, see Source: Chapra, S. and R. Canale. Numerical Methods for Engineers. McGraw-Hill, 005. g i, i, i, fi, x PFJL Lecture 14, 14

15 Partial Differential Equations Parabolic PDE: B - 4 A C = 0 (from Lecture 9) Examples T T f, ( ) t c c u u t g Heat conduction equation, forced or not (dominant in 1D) Unsteady, diffusive, small amplitude flows or perturbations (e.g. Stokes Flow) Usually smooth solutions ( diffusion effect present) t Propagation problems Domain of dependence of solution is domain D ( x, y, and 0 < t < ): BC 1: T(0,0,t)=f 1 (t) D( x, y, 0 < t < ) BC : T(L x,l y,t)=f (t) Finite Differences/Volumes, Finite Elements IC: T(x,y,0)=F(x,y) PFJL Lecture 14, 15 0 L x,l y x, y

16 (from Lecture 9) Partial Differential Equations Parabolic PDE: 1D Heat Conduction example Heat Conduction Equation ( ( T x, t T x, t,0 x L,0 t t xx Insulation Initial Condition ( Boundary Conditions s c T x,0 f ( x),0 x L T(0, t) g ( t),0 t 1 T( L, t) g ( t),0 t x = 0 T(0,t) = g 1 (t) Rod x = L T(L,t)=g (t) x PFJL Lecture 14, 16

17 Parabolic PDE 1D Heat Conduction: Forward in time, centered in space, explicit (from Lecture 9) Discretization Equidistant Sampling t F-C: computational stencil Forward (Euler) Finite Difference in time T( xi, t 1) T( xi, t ) T(0,t)=g 1 (t) Tt ( x, t) O( k) k Centered Finite Difference in space T( xi 1, t ) T( xi, t ) T( xi 1, t ) Txx( x, t) O( h ) h Ti, T( xi, t ) Finite Difference Equation T T T T T k h i, 1 i, i 1, i, i 1, i-1 i i+1 T(x,0) = f(x) T(L,t)=g (t) +1-1 x PFJL Lecture 14, 17

18 Parabolic PDE 1D Heat Conduction: Forward in time, centered in space, explicit Dimensionless diffusion coefficient Explicit Finite Difference Scheme ( k r h T 1 r T r ( T T ) i, 1 i, i1, i1, t F-C: computational stencil Stability Requirement r <= 0.5 T(0,t)=g 1 (t) T(L,t)=g (t) +1-1 Conditionally stable (von Neumann) Shown in class on blackboard i-1 i i+1 T(x,0) = f(x) x PFJL Lecture 14, 18

19 Heat Conduction Equation Explicit Finite Differences (1D-in-space, unsteady case; similar to steady elliptic problem seen previously) T denoted by u, i.e. α denoted by c, i.e. u c i, i, T L=1; T=0.; c=1; N=5; h=l/n; M=10; k=t/m; r=c^*k/h^ heat_fw.m x=[0:h:l]'; t=[0:k:t]; fx='4*x-4*x.^'; g1x='0'; gx='0'; f=inline(fx,'x'); g1=inline(g1x,'t'); g=inline(gx,'t'); n=length(x); m=length(t); u=zeros(n,m); u(:n-1,1)=f(x(:n-1)); u(1,1:m)=g1(t); u(n,1:m)=g(t); for =1:m-1 for i=:n-1 u(i,+1)=(1-*r)*u(i,) + r*(u(i+1,)+u(i-1,)); end end. figure(4) mesh(t,x,u); a=ylabel('x'); set(a,'fontsize',14); a=xlabel('t'); set(a,'fontsize',14); a=title(['forward Euler - r =' numstr(r)]); set(a,'fontsize',16); ICs: BCs: 0. PFJL Lecture 14, 19

20 Heat Conduction Equation Explicit Finite Differences L=1; T=0.333; c=1; N=5; h=l/n; M=10; k=t/m; r=c^*k/h^ heat_fw_.m ICs: 0.33 x=[0:h:l]'; t=[0:k:t]; fx='4*x-4*x.^'; g1x='0'; gx='0'; f=inline(fx,'x'); g1=inline(g1x,'t'); g=inline(gx,'t'); n=length(x); m=length(t); u=zeros(n,m); u(:n-1,1)=f(x(:n-1)); u(1,1:m)=g1(t); u(n,1:m)=g(t); for =1:m-1 for i=:n-1 u(i,+1)=(1-*r)*u(i,) + r*(u(i+1,)+u(i-1,)); end end. figure(4) mesh(t,x,u); a=ylabel('x'); set(a,'fontsize',14); a=xlabel('t'); set(a,'fontsize',14); a=title(['forward Euler - r =' numstr(r)]); set(a,'fontsize',16); BCs: PFJL Lecture 14, 0

21 Parabolic PDE: Implicit Schemes Leads to a system of equations to be solved at each time-step B-C (Backward-Centered): 1 st order accurate in time, nd order in space Unconditionally stable x i-1 Simple implicit method t l+1 t l x i x i+1 Grid point involved in time difference Grid point involved in space difference B-C: Backward in time Centered in space Evaluates RHS at time t+1 instead of time t (for the explicit scheme) Crank-Nicolson: nd order accurate in time, nd order in space Unconditionally stable x i-1 Crank-Nicolson method t l+1 t l+1/ t l x i x i+1 Grid point involved in time difference Grid point involved in space difference Time: centered FD, but evaluated at mid-point nd derivative in space determined at mid-point by averaging at t and t+1 Image by MIT OpenCourseWare. After Chapra, S., and R. Canale. Numerical Methods for Engineers. McGraw-Hill, 005. PFJL Lecture 14, 1

22 Parabolic PDE: Implicit Schemes Crank-Nicolson Scheme Equidistant Sampling t Discretization Mid-point Finite Difference in time u(0,t)=g 1 (t) u(l,t)=g (t) +1 Finite Difference Equation Crank-Nicholson Implicit Scheme i-1 i i+1 u(x,0) = f(x) x Unconditionally stable (by Von Neumann) PFJL Lecture 14,

23 Parabolic PDEs: Implicit Schemes Crank-Nicolson special case of r = 1 +1 PFJL Lecture 14, 3

24 L=1; T=0.333; c=1; N=5; h=l/n; M=10; k=t/m; r=c^*k/h^ Heat Flow Equation Implicit Crank-Nicolson Scheme heat_cn.m ICs: x=[0:h:l]'; t=[0:k:t]; fx='4*x-4*x.^'; g1x='0'; gx='0'; f=inline(fx,'x'); g1=inline(g1x,'t'); g=inline(gx,'t'); n=length(x); m=length(t); u=zeros(n,m); u(:n-1,1)=f(x(:n-1)); u(1,1:m)=g1(t); u(n,1:m)=g(t); % set up Crank-Nicholson coef matrix d=(+*r)*ones(n-,1); b=-r*ones(n-,1); c=b; % LU factorization [alf,bet]=lu_tri(d,b,c); for =1:m-1 rhs=r*(u(1:n-,)+u(3:n,)) +(-*r)*u(:n-1,); rhs(1) = rhs(1)+r*u(1,+1); rhs(n-)=rhs(n-)+r*u(n,+1); % Forward substitution z=forw_tri(rhs,bet); % Back substitution y_b=back_tri(z,alf,c); for i=:n-1 u(i,+1)=y_b(i-1); end end BCs: PFJL Lecture 14, 4

25 L=1; T=0.1; c=1; N=10; h=l/n; M=10; k=t/m; r=c^*k/h^ Heat Flow Equation Implicit Crank-Nicolson Scheme heat_cn_sin.m x=[0:h:l]'; t=[0:k:t]; fx='sin(pi*x)+sin(3*pi*x)'; g1x='0'; gx='0'; f=inline(fx,'x'); g1=inline(g1x,'t'); g=inline(gx,'t'); n=length(x); m=length(t); u=zeros(n,m); u(:n-1,1)=f(x(:n-1)); u(1,1:m)=g1(t); u(n,1:m)=g(t); % set up Crank-Nicholson coef matrix d=(+*r)*ones(n-,1); b=-r*ones(n-,1); c=b; % LU factorization [alf,bet]=lu_tri(d,b,c); for =1:m-1 rhs=r*(u(1:n-,)+u(3:n,)) +(-*r)*u(:n-1,); rhs(1) = rhs(1)+r*u(1,+1); rhs(n-)=rhs(n-)+r*u(n,+1); % Forward substitution z=forw_tri(rhs,bet); % Back substitution y_b=back_tri(z,alf,c); for i=:n-1 u(i,+1)=y_b(i-1); end end Initial Condition Analytical Solution PFJL Lecture 14, 5

26 Parabolic PDEs: Two spatial dimensions Example: Heat conduction equation/unsteady diffusive (e.g. negligible flow, no convection) Standard explicit and implicit schemes (t = nδt, x = iδx, y= Δy) n1 n n n n n n n Ti, Ti, Ti 1, Ti, Ti 1, Ti, 1 Ti, Ti, 1 c c O( t), O( x y ) t x y Stringent stability criterion: 1 x y tc 1 t For uniform grid: r 8 c x 4 Explicit: Implicit: T T T c, (0 t, 0 x L, 0 ) x y Ly t x y T T T T T T T T Crank-Nicolson Implicit (for Δx=Δy) O( t ), O( x ) n1 n r n1 n1 n1 n1 r n n n n (1 r) Ti, (1 r) Ti, ( Ti 1, Ti 1, Ti, 1 Ti, 1 ( Ti 1, Ti 1, Ti, 1 Ti, 1 Centered in time over dt = Sum explicit and implicit RHSs (given above), divided by two ( n1 n n1 n1 n1 n1 n1 n1 i, i, i1, i, i1, i, 1 i, i, 1 c c O t O x y t x y ( ( ( ), ( ) PFJL Lecture 14, 6

27 Parabolic PDEs: Two spatial dimensions Crank-Nicolson Implicit (for Δx=Δy): 1 r r (1 r) T (1 r) T T T T T T T T T Five unknowns at the (n+1) time => penta-diagonal Either elimination procedure or iterative scheme (Jacobi/Gauss- Seidel/SOR) but not always efficient ( ( n n n n n n n n n n i, i, i 1, i 1, i, 1 i, 1 i 1, i 1, i, 1 i, 1 Alternating-Direction Implicit (ADI) schemes Provides a mean for solving parabolic PDEs with tri-diagonal matrices In D: each time increment is executed in two half steps: each step is conditionally stable, but combination of two half-steps is unconditionally stable (similar to Crank-Nicolson behavior) It is one but a group of schemes called splitting methods Extended to 3D (time increment divided in 3): varied stability properties PFJL Lecture 14, 7

28 Parabolic PDEs: Two spatial dimensions ADI scheme (Two Half steps in time) t McGraw-Hill. All rights reserved. This content is excluded from our Creative Commons license. For more information, see Source: Chapra, S., and R. Canale. Numerical Methods for Engineers. McGraw-Hill, ) From time n to n+1/: Approximation of nd order x derivative is explicit, while the y derivative is implicit. Hence, tri-diagonal matrix to be solved: T T T T T T T T n1/ n n n n n1/ n1/ n1/ i, i, i1, i, i1, i, 1 i, i, 1 c c O x y t / x y ( ( ) ) From time n+1/ to n+1: Approximation of nd order x derivative is implicit, while the y derivative is explicit. Another tri-diagonal matrix to be solved: T T T T T T T T n1 n1/ n1 n1 n1 n1/ n1/ n1/ i, i, i1, i, i1, i, 1 i, i, 1 c c O x y t / x y ( ( ) PFJL Lecture 14, 8

29 Parabolic PDEs: Two spatial dimensions ADI scheme (Two Half steps in time) i=1 i= i=3 i=1 i= i=3 =3 = =1 y First direction Second direction x The ADI method applied along the y direction and x direction. This method only yields tridiagonal equations if applied along the implicit dimension. For Δx=Δy: Image by MIT OpenCourseWare. After Chapra, S., and R. Canale. Numerical Methods for Engineers. McGraw-Hill, ) From time n to n+1/: rt n 1/ i, 1 (1 r ) T n 1/ rt n 1/ rt n (1 r )T n rt n i, i, 1 i 1, i, i 1, ) From time n+1/ to n+1: rt n 1 i 1, n 1 (1 r ) T i, rt n 1 rt n 1/ i 1, i, 1 (1 r )T i, rt i n 1/ n 1/, 1 PFJL Lecture 17, 4

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

More information

Numerical 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

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

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

Basic Aspects of Discretization

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

More information

Finite 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

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

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

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

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

Computer Aided Design of Thermal Systems (ME648)

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

More information

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

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

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

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

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

Cache Oblivious Stencil Computations

Cache Oblivious Stencil Computations Cache Oblivious Stencil Computations S. HUNOLD J. L. TRÄFF F. VERSACI Lectures on High Performance Computing 13 April 2015 F. Versaci (TU Wien) Cache Oblivious Stencil Computations 13 April 2015 1 / 19

More information

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 5

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 5 .9 Numerical Fluid Mechanics Fall 011 Lecture 5 REVIEW Lecture 4 Roots of nonlinear equations: Open Methods Fixed-point Iteration (General method or Picard Iteration), with examples Iteration rule: x g(

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

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

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

More information

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

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

Lecture 16: Relaxation methods

Lecture 16: Relaxation methods Lecture 16: Relaxation methods Clever technique which begins with a first guess of the trajectory across the entire interval Break the interval into M small steps: x 1 =0, x 2,..x M =L Form a grid of points,

More information

Introduction to Heat and Mass Transfer. Week 8

Introduction to Heat and Mass Transfer. Week 8 Introduction to Heat and Mass Transfer Week 8 Next Topic Transient Conduction» Analytical Method Plane Wall Radial Systems Semi-infinite Solid Multidimensional Effects Analytical Method Lumped system analysis

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

Block-Structured Adaptive Mesh Refinement

Block-Structured Adaptive Mesh Refinement Block-Structured Adaptive Mesh Refinement Lecture 2 Incompressible Navier-Stokes Equations Fractional Step Scheme 1-D AMR for classical PDE s hyperbolic elliptic parabolic Accuracy considerations Bell

More information

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

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

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

More information

Chapter 5. Methods for Solving Elliptic Equations

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

More information

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

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

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

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

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

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II Elliptic Problems / Multigrid Summary of Hyperbolic PDEs We looked at a simple linear and a nonlinear scalar hyperbolic PDE There is a speed associated with the change of the solution Explicit methods

More information

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

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

More information

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

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

More information

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

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

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

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

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

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

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

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

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

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

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

Numerical Algorithms for Visual Computing II 2010/11 Example Solutions for Assignment 6

Numerical Algorithms for Visual Computing II 2010/11 Example Solutions for Assignment 6 Numerical Algorithms for Visual Computing II 00/ Example Solutions for Assignment 6 Problem (Matrix Stability Infusion). The matrix A of the arising matrix notation U n+ = AU n takes the following form,

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

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

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 methods for the Navier- Stokes equations

Numerical methods for the Navier- Stokes equations Numerical methods for the Navier- Stokes equations Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Dec 6, 2012 Note:

More information

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

Computational Fluid Dynamics-1(CFDI)

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

More information

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

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

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

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

Numerical Methods of Applied Mathematics -- II Spring 2009

Numerical Methods of Applied Mathematics -- II Spring 2009 MIT OpenCourseWare http://ocw.mit.edu 18.336 Numerical Methods of Applied Mathematics -- II Spring 2009 For information about citing these materials or our Terms of Use, visit: http://ocw.mit.edu/terms.

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

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

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

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

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

Introduction to Heat and Mass Transfer. Week 7

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

More information

PowerPoints organized by Dr. Michael R. Gustafson II, Duke University

PowerPoints organized by Dr. Michael R. Gustafson II, Duke University Part 6 Chapter Boundary-Value Problems PowerPoints organized by Dr. Michael R. Gustafson II, Duke University All images copyright The McGraw-Hill Companies, Inc. Permission required for reproduction or

More information

Implicitly Defined High-Order Operator Splittings for Parabolic and Hyperbolic Variable-Coefficient PDE Using Modified Moments

Implicitly Defined High-Order Operator Splittings for Parabolic and Hyperbolic Variable-Coefficient PDE Using Modified Moments Implicitly Defined High-Order Operator Splittings for Parabolic and Hyperbolic Variable-Coefficient PDE Using Modified Moments James V. Lambers September 24, 2008 Abstract This paper presents a reformulation

More information

Introduction to PDEs and Numerical Methods Lecture 7. Solving linear systems

Introduction to PDEs and Numerical Methods Lecture 7. Solving linear systems Platzhalter für Bild, Bild auf Titelfolie hinter das Logo einsetzen Introduction to PDEs and Numerical Methods Lecture 7. Solving linear systems Dr. Noemi Friedman, 09.2.205. Reminder: Instationary heat

More information

Review for Exam 2 Ben Wang and Mark Styczynski

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

More information

Numerical Solution of One-dimensional Telegraph Equation using Cubic B-spline Collocation Method

Numerical Solution of One-dimensional Telegraph Equation using Cubic B-spline Collocation Method 2014 (2014) 1-8 Available online at www.ispacs.com/iasc Volume 2014, Year 2014 Article ID iasc-00042, 8 Pages doi:10.5899/2014/iasc-00042 Research Article Numerical Solution of One-dimensional Telegraph

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

Code: 101MAT4 101MT4B. Today s topics Finite-difference method in 2D. Poisson equation Wave equation

Code: 101MAT4 101MT4B. Today s topics Finite-difference method in 2D. Poisson equation Wave equation Code: MAT MTB Today s topics Finite-difference method in D Poisson equation Wave equation Finite-difference method for elliptic PDEs in D Recall that u is the short version of u x + u y Dirichlet BVP:

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

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications)

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications) Chapter 6 Finite Element Method Literature: (tiny selection from an enormous number of publications) K.J. Bathe, Finite Element procedures, 2nd edition, Pearson 2014 (1043 pages, comprehensive). Available

More information

M.Sc. in Meteorology. Numerical Weather Prediction

M.Sc. in Meteorology. Numerical Weather Prediction M.Sc. in Meteorology UCD Numerical Weather Prediction Prof Peter Lynch Meteorology & Climate Centre School of Mathematical Sciences University College Dublin Second Semester, 2005 2006. In this section

More information