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

Size: px
Start display at page:

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

Transcription

1 MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS NUMERICAL FLUID MECHANICS FALL 2011 QUIZ 2 The goals of this quiz 2 are to: (i) ask some general higher-level questions to ensure you understand broad concepts and are able to discuss such concepts and issues with others familiar with numerical fluid mechanics; (ii) show that you understand and can apply concepts, methods and schemes that you learned; and (iii), show that you are able to read numerical codes and recognize what they accomplish. Partial credit will be given to partial answers. Shorter Concept Questions Problem 1 (25 points) Please provide a brief answer to the following questions (a few words to a few sentences is enough, with or without a few equations depending on the question). a) Provide two limitations of the von Neumann stability analysis. b) Explain how the discretization error and order of accuracy can be estimated numerically, without knowing the true solution. If you find that the estimated order of accuracy is not as expected, what are three possible causes? c) You evaluate the stability of your advection scheme and you find that the Courant-Friedrichs-Lewy condition does not give you the same condition as a von Neumann stability analysis. Which of the two conditions are you going to utilize, if any? Why? d) Briefly state three advantages that Multistep methods have over Runge-Kutta methods and three advantages that Runge-Kutta methods have over Multistep methods. e) The effective wave speeds of numerical representations of advection schemes are usually smaller than the real wave speed and usually dependent on the wavenumber. Briefly explain what this implies for numerical simulations. f) A friend tells you that for your FV scheme, you should always initialize your solution by computing the integral of your initial conditions over each finite volume. Otherwise, she says, your nodal values will not represent the volume average over the cell. Another friend tells you that you can initialize with the initial conditions evaluated at the nodal centers and that you should not bother doing integrals since it will be within the truncation errors. Are both of your friends right or wrong, or is only one of them right? Briefly explain why. g) To simulate a turbulent pipe flow systems with bends and corners, your friend recommends a non-orthogonal shape-following finite-volume grid, with a staggered pressure and velocity arrangements, specifically: pressure at nodal points and Cartesian-coordinate velocities at the boundaries of these pressure finite-volumes. Is this a good idea or not? Briefly explain why. Solution Notes: Some of the answers provided are much more complete than required for full credit. a) Some of the limitations of the von Neumann stability analysis are that in the theoretical sense, it only applies only to periodic BC problems and to linear problems (with constant coefficients). It also assumes that errors can be represented as Fourier series. b) The discretization error and order of accuracy can be estimated numerically, without knowing the true solution, by computing three and two solutions on systematically refined/coarsened grids, p respectively. The true solution u can be expressed either as u u x x R, or p uu2 x '(2 x) R' or u u4 '' (2 ) p x x R''. Assuming the three s and R s are similar, one eliminates u, the s and the R s to obtain: - 1 -

2 u - With three solutions: 2x u 4x p log log 2 u x u2 x u - With two solutions (assuming p is known): x u2x x p 2 1 If the estimated order of accuracy is not as expected, possible causes are: a bug in the code; the finitedifference scheme is not stable (e.g. a CFL condition is not satisfied for some of the solutions); the discretization of the boundary conditions are not of the same order as the order of the interior finitedifferences; the initial and/or boundary conditions are such that nonlinear terms and derivatives are (locally) significant; the resolution is too coarse (for the truncation error term to behave as ( ) ˆ p x x( ) O( x ) for x0); the (linear)-system solver does not converge (or is not applicable) and/or the system is poorly conditioned; the grid refinement is not systematic in complex geometrical cases; or, the round-off errors amplify (which is often less frequent than the other cases). c) If when evaluating the stability of an advection scheme, you find that the CFL condition does not give the same condition as a von Neumann stability analysis, you would utilize the stricter of the two since neither is always sufficient. However, it is very likely that the stricter of the two is the von Neumann condition since it often provides a sufficient condition for stability (in addition to always providing a necessary condition). A von Neumann condition is thus often more restrictive than a CFL condition. However, if the CFL is more restrictive, then one would use the CFL. In general, in multidimensional and multi-scale problems, one may also utilize a combination of (local) stability conditions. This is because: i) different terms in the PDEs can dominate the solution locally (in time or space) and, ii) estimating a stability condition valid everywhere in the domain, for all initial and boundary conditions, is not often feasible in such complex cases. d) To integrate over [t n+1, t n ], advantages of Multistep methods include: i) only one new RHS is needed at each time step; ii) accuracy is increased by adding points at previous time steps (at which the solution and so the RHS have already been computed), hence they are less expensive for a given order than RK methods (RKs are more expensive since the n th order RK requires n evaluations of the RHS, the 1 st derivative); iii) smaller stencils are needed for implicit multistep schemes (only values at t n+1 needed); iv) stores RHS/solutions only at chosen time-steps (not at intermediate steps); iv) can be easier to code. Advantages of RK methods include: i) for a given order, RK methods are more accurate and more stable than multistep methods of same order; ii) high-order multistep methods use derivatives that could be irrelevant to what is going on during [t n+1, t n ] (RKs use derivatives within [t n+1, t n ], a reason why RKs are more stable); iii) RKs are directly started but it is more difficult to start Multistep methods; and, iv) Multistep methods require storing old solutions (at past time steps). e) Since effective wave speeds of numerical representations of advection schemes are usually smaller than the real wave speed and usually dependent on the wavenumber, numerical simulations will lead to waves that travel a slower speeds than in reality and will numerically disperse a given wave (introduce other frequencies). f) Both friends can be right or wrong. If one initializes the solution by computing the integral of the ICs over each FV, the nodal values will represent the volume average over the cell and everything will be consistent. However, if the FV scheme is 2 nd order (e.g. mi-point rule is employed for integrals), then you could initialize with the ICs evaluated at the nodal centers since the mid-point value is equal to the integral-average over the cell at second order, hence differences will be within the truncation errors. Note we assumed in both cases that FVs are cell centered and FVs are sufficiently refined. g) To simulate a turbulent pipe flow systems with bends and corners, the idea of a non-orthogonal shape-following finite-volume grid, with a staggered pressure and velocity arrangements, and pressure at nodal points is good. However, if you utilize Cartesian-coordinate velocities at the boundaries of these pressure finite-volumes, this is likely to lead to velocities that are (quasi)-parallel to the edges some of the FVs. These FVs would be very ill posed: i.e. large variations in velocities and their errors would lead to small variations in the fluxes and their errors, and vice-versa

3 Idealized Computational Problems Problem 2: Local Stability of a Numerical Scheme (30 points) Consider the following one-dimensional temperature diffusion, 2 T T 2 t x and its discretization, n1 n n1 n1 n1 n n n Tj T j Tj 1 2Tj Tj 1 Tj 12Tj T j1 (1 ) 2 2 with0 1 t x x t and define r. 2 x a) Determine the leading term of the local truncation error in terms of r, and temperature derivatives at time n and point j. What are the orders of accuracy of the discretized equation in time and in space? b) Using your result in a) provide an expression for * () r that maximizes these orders of accuracy in time and space for a given r. What are these maximum orders of accuracy? c) Using a von Neumann stability analysis, determine the stability criterion for the discretized equation. 1 1 d) Based on your results in c), discuss 4 cases: 0,, and 1, expressing in 2 2 each case the stability conditions on r. Relate your results to the forward Euler (classic explicit), backward Euler (classic implicit) and Crank-Nicolson schemes. e) How does the cost of the scheme obtained in b) with * () r compare to that of the Crank-Nicolson scheme? f) Using your von Neumann analysis in c-d), provide a condition which guarantees no oscillation of the errors and a condition which guarantees constant signs for discrete temperatures (and their errors). Very briefly discuss the results. g) If you were to utilize the above discretization to determine the steady state temperature, which range of values for would you choose? Why? Can you utilize any values for r? - 3 -

4

5

6

7

8

9

10

11 Problem 3: Finite Volumes on Triangles. (25 points) Consider the conservative form of a partial differential equation governing the two-dimensional (2D) in space advection-diffusion-reaction of a variable per unit volume (a surface in 2D):.( v).( ) s n t A finite-volume discretization is employed to solve this equation numerically, using equilateral triangles over the given domain. A representative triangle is illustrated on Figure 1: triangles have sides of length L and are fixed in time and space. The finite-volume discretization is node-centered for. Velocities are staggered and defined normal and outward to the edges of each triangle. a) Utilizing a mid-point rule for the surface (volume) integrals, provide the spatial discretization of the time-rate of change term and of the source term for the center triangle P. b) Discretize the convective fluxes for the center triangle P, using a mid-point rule for W sw n w s P n S e n E se Figure 1. Representative equilateral triangle, with center node P and sides of length L. The center nodes of the west, east and south triangles are denoted as W, E and S, respectively. the edge integral and linear interpolation to estimate the center edge values in terms of nodal values. c) Discretize the diffusive fluxes for the center triangle P, using a mid-point rule for the edge integral and linear interpolation of fluxes (centered difference) to estimate the center edge fluxes in terms of nodal values. d) For the given discretizations, do you need to resolve flux discontinuities in b) and/or c) to ensure conservative flux discretizations? If yes, please do so. If not, explain why. e) Combining a)-d), write the resulting finite-volume discretization for center triangle P. f) Should the triangle not be equilateral, what would be the order of accuracy of the spatial discretization obtained in e)? What is the main reason for this result? - 4 -

12 Solution: Consider the integral form of the governing differential equation (Integrate over the control volume V):.( v).( ) s t dv.( v) dv.( ) dv s dv t We are asked to evaluate each of these terms individually using different interpolations and approximations. a. (5 points) Time rate of change term (using a midpoint rule to evaluate volume integrals): d dp T1 dv dv PdV V t t dt dt The control volume in our case is the shaded equilateral triangle of side length L and unit thickness normal to the plane. The area of this equilateral triangle is given by: 3 2 A L 4 Therefore, 3 2 V L 4 We finally, have the approximate spatial discretization of the time rate of change term as: 3 d 2 P T1 L 4 dt The source term is also handled in a similar manner: This gives: T S dv S dv VS 4 P P T4 L S P b. (5 points) The convective term and the diffusive term are a little more complicated to deal with. Convective flux: T2.( v) dv - 5 -

13 Using Gauss theorem, the above volume integral can be transformed into a surface integral as follows: T dv v nds 2.( v). Using a linear interpolation for edge centered values and a mid-point rule for the surface integral, the above expression reduces to: T v. nds L v. n 2 int Since the control volume has three edges, the above term will have three different contributions. e P E 1. Edge n-se: T2 v. nds Lev. n Lve 2 w P W 2. Edge n-sw: T2 v. nds Lwv. n Lvw 2 s P S 3. Edge sw-se: T2 v. nds Lsv. n Lvs 2 Finally, we get: P S P W P E T2 Lvs Lvw Lve c. (5 points) Diffusive Fluxes: These fluxes are handled similar to advective fluxes. We have, T dv nds 3.( ). Using midpoint rule for the edge integrals and linear interpolation for edge centered values we get: d T3. nds L dn Since the CV has three edges, we again get three different contributions to the diffusive fluxes. e d E P 1. Edge n-se: T3 L L 3 E P dn L 3 2 w T 2. Edge n-sw: 3 3 W P s 3. Edge sw-se: T Finally, we get: 3 3 S P - 6 -

14 T3 3 E P 3 W P 3 S P d. (4 points) The advective and diffusive fluxes at the edge of a CV are exactly equal and opposite to the fluxes at the same edge due to the neighboring CV. This means that when the integral form of the equation is solved in the entire domain, the interior fluxes cancel out. Therefore, there is no flux discontinuity at the boundaries of neighboring CVs. e. (2 points) Putting every term of the integral form together, we have the following governing equation: f. (4 points) 3 2 dp P S P W P E L Lvs Lvw Lve 4 dt E P 3W P 3S P LS P 4 When the triangles are not equilateral, the discretization will no longer be second order accurate. This is because the normals from adjacent triangles will not line up in the same direction. When the triangles are equilateral, the cell centers are equidistant, due to which, the first order term in the Taylor series expansion cancels out. This leaves only the second order term as the leading term in the truncation error. When the triangles have different sizes, the centers are no longer equidistant from each other and this leads to a scheme which is only first order accurate

15 Problem 4: Code for solving a PDE (20 points) The MATLAB code for solving a PDE is given below: % MATLAB Code for solving a PDE. clear all,clc,clf, close all; % Initialize constants Nx=21; % Number of grid points x=1; % Length of domain dx=x/(nx-1); % Grid spacing Nt=601; % Total number of time steps t=1; % Final time dt=t/(nt-1); % Time step c=0.5; C = c*dt/(2*dx); % Initial conditions for i=1:nx if (dx*(i-1) >0.5) u(i,1)=1; else u(i,1)=0; end end % Fill in Matrix H: H = zeros(size(u,1),size(u,1)); for ii=3:size(u,1) H(ii,ii) = 1+3*C; H(ii,ii-1) = -4*C; H(ii,ii-2) = C; end H(1,1) = 1+3*C; H(1,end) = -4*C; H(1,end-1) = C; H(2,1) = -4*C; H(2,2) = 1+3*C; H(2,end) = C; % Fill in Matrix L; L=diag(ones(1,Nx)); for i=2:nx-1 L(i,i-1)=-C; L(i,i+1)= C; end L(1,2) = C;L(1,end) = -C; L(end,1) = C;L(end,end-1) = -C; L = inv(l); % Time integration for k = 2:Nt uold = L*u(:,k-1); unew = zeros(nx,1); iter=0; while(norm(unew-uold)>0.0001) if (iter~=0) uold = unew; end - 8 -

16 unew = L*u(:,k-1) + (eye(nx)-l*h)*uold; iter=iter+1; end u(:,k)=unew; end u_dc = u; Answer the following questions: a) Which equation is being solved by the given MATLAB code? What are the initial conditions? What type of boundary condition is implemented? b) Which types of discretization in space and time do the L and H matrices correspond to? c) Which scheme is being implemented in the code? d) Give two reasons why one would want to use this scheme. Solution: a. (6 points) The equation being solved in this code is the Sommerfeld wave equation. u u c 0 t x The initial conditions are as follows: Periodic boundary conditions are implemented. ux ( 0.5) 0 ux ( 0.5) 1 b. (5 points) The L matrix stands for the coefficient matrix obtained by discretizing the equation using a backward difference in time and a central difference in space. You can see this by looking at the structure of the L matrix. It is tri diagonal with minor modifications at the top-right and bottomleft of the matrix to incorporate the periodic boundary conditions. H matrix is obtained by discretizing the equation by using a backward difference in time and a second order backward difference in space. The idea is to call them Lower (L) and Higher (H) because we want to solve the equation without having to invert H, which can possibly be dense. c. (5 points) The scheme implemented in the code is a deferred correction approach. It is an iterative scheme using which one obtains the solution of a higher order method without actually having to invert a large coefficient matrix. Using the solution of a lower order scheme, one can iteratively update the solution until the solution becomes higher order accurate

17 d. (4 points) The main reasons one would use a deferred correction approach is: 1. Reduce oscillations in the solution 2. Avoid inversion of a large H matrix

18 MIT OpenCourseWare Numerical Fluid Mechanics Fall 2011 For information about citing these materials or our Terms of Use, visit:

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

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

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

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

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

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

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

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

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

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

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

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

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

Finite Difference Methods (FDMs) 1

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

More information

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

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

Chapter 9 Implicit Methods for Linear and Nonlinear Systems of ODEs

Chapter 9 Implicit Methods for Linear and Nonlinear Systems of ODEs Chapter 9 Implicit Methods for Linear and Nonlinear Systems of ODEs In the previous chapter, we investigated stiffness in ODEs. Recall that an ODE is stiff if it exhibits behavior on widelyvarying timescales.

More information

Solution Methods. Steady State Diffusion Equation. Lecture 04

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

More information

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

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

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

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

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

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

Computational Fluid Dynamics Prof. Dr. Suman Chakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur

Computational Fluid Dynamics Prof. Dr. Suman Chakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur Computational Fluid Dynamics Prof. Dr. Suman Chakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur Lecture No. #12 Fundamentals of Discretization: Finite Volume Method

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

Solution Methods. Steady convection-diffusion equation. Lecture 05

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

More information

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

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 2 Finite-Difference Discretization of the Advection-Diffusion Equation

Chapter 2 Finite-Difference Discretization of the Advection-Diffusion Equation Chapter Finite-Difference Discretization of the Advection-Diffusion Equation. Introduction Finite-difference methods are numerical methods that find solutions to differential equations using approximate

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

Computation of Incompressible Flows: SIMPLE and related Algorithms

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

More information

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

Ordinary Differential Equations

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

More information

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

A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws

A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws Kilian Cooley 1 Prof. James Baeder 2 1 Department of Mathematics, University of Maryland - College Park 2 Department of Aerospace

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

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

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

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

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

More information

Chapter 1. Introduction

Chapter 1. Introduction Chapter 1 Introduction Many astrophysical scenarios are modeled using the field equations of fluid dynamics. Fluids are generally challenging systems to describe analytically, as they form a nonlinear

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

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

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

Preliminary Examination in Numerical Analysis

Preliminary Examination in Numerical Analysis Department of Applied Mathematics Preliminary Examination in Numerical Analysis August 7, 06, 0 am pm. Submit solutions to four (and no more) of the following six problems. Show all your work, and justify

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

ME Computational Fluid Mechanics Lecture 5

ME Computational Fluid Mechanics Lecture 5 ME - 733 Computational Fluid Mechanics Lecture 5 Dr./ Ahmed Nagib Elmekawy Dec. 20, 2018 Elliptic PDEs: Finite Difference Formulation Using central difference formulation, the so called five-point formula

More information

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

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

More information

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

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

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

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

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

30 crete maximum principle, which all imply the bound-preserving property. But most

30 crete maximum principle, which all imply the bound-preserving property. But most 3 4 7 8 9 3 4 7 A HIGH ORDER ACCURATE BOUND-PRESERVING COMPACT FINITE DIFFERENCE SCHEME FOR SCALAR CONVECTION DIFFUSION EQUATIONS HAO LI, SHUSEN XIE, AND XIANGXIONG ZHANG Abstract We show that the classical

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

A Brief Introduction to Numerical Methods for Differential Equations

A Brief Introduction to Numerical Methods for Differential Equations A Brief Introduction to Numerical Methods for Differential Equations January 10, 2011 This tutorial introduces some basic numerical computation techniques that are useful for the simulation and analysis

More information

Lecture 42 Determining Internal Node Values

Lecture 42 Determining Internal Node Values Lecture 42 Determining Internal Node Values As seen in the previous section, a finite element solution of a boundary value problem boils down to finding the best values of the constants {C j } n, which

More information

Computational Fluid Dynamics Prof. Dr. SumanChakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur

Computational Fluid Dynamics Prof. Dr. SumanChakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur Computational Fluid Dynamics Prof. Dr. SumanChakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur Lecture No. #11 Fundamentals of Discretization: Finite Difference

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

Partial Differential Equations (PDEs) and the Finite Difference Method (FDM). An introduction

Partial Differential Equations (PDEs) and the Finite Difference Method (FDM). An introduction Page of 8 Partial Differential Equations (PDEs) and the Finite Difference Method (FDM). An introduction FILE:Chap 3 Partial Differential Equations-V6. Original: May 7, 05 Revised: Dec 9, 06, Feb 0, 07,

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

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

Review Higher Order methods Multistep methods Summary HIGHER ORDER METHODS. P.V. Johnson. School of Mathematics. Semester

Review Higher Order methods Multistep methods Summary HIGHER ORDER METHODS. P.V. Johnson. School of Mathematics. Semester HIGHER ORDER METHODS School of Mathematics Semester 1 2008 OUTLINE 1 REVIEW 2 HIGHER ORDER METHODS 3 MULTISTEP METHODS 4 SUMMARY OUTLINE 1 REVIEW 2 HIGHER ORDER METHODS 3 MULTISTEP METHODS 4 SUMMARY OUTLINE

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

Some notes about PDEs. -Bill Green Nov. 2015

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

More information

The family of Runge Kutta methods with two intermediate evaluations is defined by

The family of Runge Kutta methods with two intermediate evaluations is defined by AM 205: lecture 13 Last time: Numerical solution of ordinary differential equations Today: Additional ODE methods, boundary value problems Thursday s lecture will be given by Thomas Fai Assignment 3 will

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

A Study on Numerical Solution to the Incompressible Navier-Stokes Equation

A Study on Numerical Solution to the Incompressible Navier-Stokes Equation A Study on Numerical Solution to the Incompressible Navier-Stokes Equation Zipeng Zhao May 2014 1 Introduction 1.1 Motivation One of the most important applications of finite differences lies in the field

More information

Chapter 9 Implicit integration, incompressible flows

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

More information

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

Chapter 11 ORDINARY DIFFERENTIAL EQUATIONS

Chapter 11 ORDINARY DIFFERENTIAL EQUATIONS Chapter 11 ORDINARY DIFFERENTIAL EQUATIONS The general form of a first order differential equations is = f(x, y) with initial condition y(a) = y a We seek the solution y = y(x) for x > a This is shown

More information

Study of Forced and Free convection in Lid driven cavity problem

Study of Forced and Free convection in Lid driven cavity problem MIT Study of Forced and Free convection in Lid driven cavity problem 18.086 Project report Divya Panchanathan 5-11-2014 Aim To solve the Navier-stokes momentum equations for a lid driven cavity problem

More information

Introduction - Motivation. Many phenomena (physical, chemical, biological, etc.) are model by differential equations. f f(x + h) f(x) (x) = lim

Introduction - Motivation. Many phenomena (physical, chemical, biological, etc.) are model by differential equations. f f(x + h) f(x) (x) = lim Introduction - Motivation Many phenomena (physical, chemical, biological, etc.) are model by differential equations. Recall the definition of the derivative of f(x) f f(x + h) f(x) (x) = lim. h 0 h Its

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

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

Appendix C: Recapitulation of Numerical schemes

Appendix C: Recapitulation of Numerical schemes Appendix C: Recapitulation of Numerical schemes August 31, 2009) SUMMARY: Certain numerical schemes of general use are regrouped here in order to facilitate implementations of simple models C1 The tridiagonal

More information

Numerical Hydraulics

Numerical Hydraulics ETHZ, Fall 017 Numerical Hydraulics Assignment 4 Numerical solution of 1D solute transport using Matlab http://www.bafg.de/ http://warholian.com Numerical Hydraulics Assignment 4 ETH 017 1 Introduction

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

Numerical methods Revised March 2001

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

More information

Numerical Methods for Partial Differential Equations. CAAM 452 Spring 2005 Lecture 2 Instructor: Tim Warburton

Numerical Methods for Partial Differential Equations. CAAM 452 Spring 2005 Lecture 2 Instructor: Tim Warburton Numerical Methods for Partial Differential Equations CAAM 452 Spring 2005 Lecture 2 Instructor: Tim Warburton Note on textbook for finite difference methods Due to the difficulty some students have experienced

More information

Project 4: Navier-Stokes Solution to Driven Cavity and Channel Flow Conditions

Project 4: Navier-Stokes Solution to Driven Cavity and Channel Flow Conditions Project 4: Navier-Stokes Solution to Driven Cavity and Channel Flow Conditions R. S. Sellers MAE 5440, Computational Fluid Dynamics Utah State University, Department of Mechanical and Aerospace Engineering

More information

A numerical study of SSP time integration methods for hyperbolic conservation laws

A numerical study of SSP time integration methods for hyperbolic conservation laws MATHEMATICAL COMMUNICATIONS 613 Math. Commun., Vol. 15, No., pp. 613-633 (010) A numerical study of SSP time integration methods for hyperbolic conservation laws Nelida Črnjarić Žic1,, Bojan Crnković 1

More information

A THEORETICAL INTRODUCTION TO NUMERICAL ANALYSIS

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

More information

Discretization of Convection Diffusion type equation

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

More information

Lecture V: The game-engine loop & Time Integration

Lecture V: The game-engine loop & Time Integration Lecture V: The game-engine loop & Time Integration The Basic Game-Engine Loop Previous state: " #, %(#) ( #, )(#) Forces -(#) Integrate velocities and positions Resolve Interpenetrations Per-body change

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

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

x x2 2 + x3 3 x4 3. Use the divided-difference method to find a polynomial of least degree that fits the values shown: (b)

x x2 2 + x3 3 x4 3. Use the divided-difference method to find a polynomial of least degree that fits the values shown: (b) Numerical Methods - PROBLEMS. The Taylor series, about the origin, for log( + x) is x x2 2 + x3 3 x4 4 + Find an upper bound on the magnitude of the truncation error on the interval x.5 when log( + x)

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

Divergence Formulation of Source Term

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

More information

Open boundary conditions in numerical simulations of unsteady incompressible flow

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

More information

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

ADER Schemes on Adaptive Triangular Meshes for Scalar Conservation Laws

ADER Schemes on Adaptive Triangular Meshes for Scalar Conservation Laws ADER Schemes on Adaptive Triangular Meshes for Scalar Conservation Laws Martin Käser and Armin Iske Abstract. ADER schemes are recent finite volume methods for hyperbolic conservation laws, which can be

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

ENO and WENO schemes. Further topics and time Integration

ENO and WENO schemes. Further topics and time Integration ENO and WENO schemes. Further topics and time Integration Tefa Kaisara CASA Seminar 29 November, 2006 Outline 1 Short review ENO/WENO 2 Further topics Subcell resolution Other building blocks 3 Time Integration

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

Fall Exam II. Wed. Nov. 9, 2005

Fall Exam II. Wed. Nov. 9, 2005 Fall 005 10.34 Eam II. Wed. Nov. 9 005 (SOLUTION) Read through the entire eam before beginning work and budget your time. You are researching drug eluting stents and wish to understand better how the drug

More information