Predictivity-I! Verification! Computational Fluid Dynamics. Computational Fluid Dynamics

Size: px
Start display at page:

Download "Predictivity-I! Verification! Computational Fluid Dynamics. Computational Fluid Dynamics"

Transcription

1 Predictivity-I! To accurately predict the behavior of a system computationally, we need:! A correct and accurate code: Verification! An model that accurately describes the process under study: Validation! Grétar Tryggvason! Spring 2011! A set of input parameters whose value and range is known: Uncertainty Quantification! Verification! From: Schlesinger, S. Terminology for Model Credibility, Simulation, Vol. 32, No. 3, 1979; Cited in W. L. Oberkampf and T.G. Trucano. Verification and Validation in. SANDIA REPORT SAND (2002)! Verification: Show that the code solves the equations that it is intended to solve with the expected accuracy. Verification consists of Code Verification (which can be done once and for all) and Solution Verification which must be done for all new problems.! Code Verification is independent of any physical reality. The goal is simply to show that it correctly solves the equations that it is intended to solve. If an exact solution is available, then it can be used. If not, the Method of Manufactured Solutions (MMS) can be used.! The key tool to verify a code and solution correctness is grid refinement.!

2 Method of Manufactured Solutions! The basic idea is to add a source term to the equations that force the solution to take a given value. Suppose we have:! L(u) = 0 Taking! u = q obviously does not satisfy this equation. However if we add a source to the RHS, given by! u = q g = L(q) Then is a solution to! L(u) = g Thus, the Method of Manufactured Solutions consists of! 1. Picking a function q 2. Computing the source term! 3. Solving the original equation with the new source term! Notice that there is no requirement that the function q satisfies the equations or that it has any physical meaning.! Trivial Example! d 2 u = 0; 0 < x < 1; u(0) = 1; u(1) = 0; 2 dx The solution is given by:! u = 1 x Take:! q = 1 x 2 ; Solve:! d 2 u dx 2 = 2; dq dx = 2x; d 2 q 2 dx = 2; g = 2 du dx = 2x + C 1 ; u = x2 + C 1 x + C 2 C 1 = 0; C 2 = 1; u = 1 x 2 As we intended!! For a more real example consider! f x = D 2 f x 2 With the manufactured solution:! q = A + sin(x + Ct) First we rewrite our equation as:! L( f ) = f x D 2 f x = 0 2 So our source is! g = q t + q q x D 2 q x 2 Our manufactured solution is! q = A + sin(x + Ct) We have! q q = C cos(x + Ct); t So the source term is! = cos(x + Ct); x 2 q = sin(x + Ct); 2 x g = C cos(x + Ct) + ( A + sin(x + Ct) )cos(x + Ct) + sin(x + Ct); From: P. J. Roache. Fundamental of Verification and Validation. Hermosa, 2009!

3 Therefore,! f = A + sin(x + Ct) Is an EXACT solution to! f x = D 2 f x + g 2 g = C cos(x + Ct) + ( A + sin(x + Ct) )cos(x + Ct) + Dsin(x + Ct); % Method of Manufactured Solution for the 1D Burgers equation! % ! n=61; nstep=2000; length=2*pi;h=length/(n-1);diff=0.05;dt=1.0/nstep! f=zeros(n,1); y=zeros(n,1); ex=zeros(n,1); time=0.0; for i=1:n; x(i)=h*(i-1);end! A=1.0; C=1.0; for i=1:n, f(i)=a+sin(x(i)); end; %initial conditions! for m=1:nstep+1,m! for i=1:n, ex(i)=a+sin(x(i)+c*time); end; %exact solution! hold off;plot(f,'linewidt',6); axis([1 n -1.0, 3.0]); % plot solution! hold on;plot(ex,'r','linewidt',2); %pause; % plot exact solution! err=0.0;for i=1:n, err=err+h*(ex(i)-f(i))^2; end;err=sqrt(err)! y=f; % store the solution! for i=2:n-1,! g=c*cos(x(i)+c*time)+(a+sin(x(i)+c*time))*cos(x(i)+c*time)+diff*sin(x(i)+c*time);! f(i)=y(i)-0.5*(dt/h)*y(i)*(y(i+1)-y(i-1))+...!! diff*(dt/h^2)*(y(i+1)-2*y(i)+y(i-1))+dt*g; % advect by centered differences! end;! g=c*cos(x(n)+c*time)+(a+sin(x(n)+c*time))*cos(x(n)+c*time)+diff*sin(x(n)+c*time);! f(n)=y(n)-0.5*(dt/h)*y(n)*(y(2)-y(n-1))+diff*(dt/h^2)*(y(2)-2*y(n)+y(n-1))+dt*g; % do endpoints! f(1)=f(n); % for periodic! time=time+dt % boundaries! end;! The error versus grid spacing! The manufactured solution is used in code verification exactly as we would use an exact solution to the original equations. If we do not, for example, get the expected convergence rate, then there must be an error somewhere! Error in boundary conditions destroys second order convergence!! Solution at time 1! 1! 2! Correct second order convergence! 1! 2! h! The manufactured solution can be selected in many different ways. We could, for example, pick:! q = e x sin( t) Which gives us the source! g = e x cos t ( ) + ( e x sin( t) ) 2 De x sin( t) For the Burgerʼs equation! f x = D 2 f x 2 From: P. J. Roache. Fundamental of Verification and Validation. Hermosa, 2009! Guidelines for the MMS! 1. Manufactured solutions should be smooth analytic functions like polynomials, trigonometric, or exponential functions so that the solution is conveniently computed.! 2. The solution should exercise every term in the equations! 3. The solution should have sufficient number of derivatives! 4. The derivatives should be bounded by small constants! 5. The solution should not prevent the code from running to completion! 6. The solution should be defined on a connected subset of twoor three-dimensional space! 7. The solution should be constructed in a manner such that the differential operators in the PDEʼs make sense.! Adopted from: K. Salari and P. Knupp. Code Verification by the Method of Manufactured Solutions. SAND (2000)!

4 Generating the source terms can be complicated for complex operators. This can, however, easily be done using symbolic manipulation software such as MAPLE or Mathematics! Verification involves two different steps:! Code verification! Generally done once to ensure that the code is correct, using for example the method of manufactured solutions! Solution verification! Done every time the code is used to produce a solution to ensure that the solution errors are acceptable (that the solution is converged)! Suppose we have a supposedly pth-order solution on two grids where h 2 =h 1 /r. The error is then! E grid1 = Ch p E grid 2 = C h r The ratio of the errors is! E grid1 = Ch p E grid 2 Ch p r p = r p p = log E grid1 E grid 2 p Which allows us to compute the actual order:! / log r ( ) The actual order p, for the Burgerʼs equation example, computed as on the previous slide! Theoretical convergence rate! h! Euler Equations for 2D Flow! Roy, Nelson, and Smith tested two codes using:! The method of manufactured solutions does not address all issues of code verification, such as domain size and boundary conditions. Nevertheless, it is emerging as one of the major tool in ensuring that a given set of equations is correctly solved.! From: C.J. Roy, C.C. Nelson, T.M. Smith, C.C. Ober, Verification of Euler/Navier Stokes codes using the method of manufacturedsolutions, Int. J. Numer. Meth. Fluids 44 (6) (2004) ! Cited in: C.J. Roy. Review of code and solution verification procedures for computational simulation. Journal of Computational Physics 205 (2005) !

5 Solution Verification (Correct code, wrong solution)! While code verification is usually done once, solution verification needs in principle to be done every time the code is used to generate a solution. In practice an experienced user will have a good idea about the necessary resolution.! A correct code but insufficient resolution or other numerical parameters (iteration errors, for example) can lead to inaccurate and even wrong solutions. For new problems the accuracy must be verified.! The approximate solution can be written as a Taylor series around the exact solution f(0):! f ( h) = f ( 0) + Ch 2 + HOT Here, f(0) is the (unknown) exact solution and C is a constant determining the magnitude of the error. Given f(h) and f(2h), estimate C. Once C is known, we can use the above formula to find a better estimate for the solution. This procedure is called Richardson Extrapolation and is widely used in practice.! We have:! f ( h) = f ( 0) + Ch 2 + HOT similarly, the solution on twice as coarse grid is:! f ( 2h) = f ( 0) + C4h 2 + HOT subtracting to eliminate the h 2 term:! 4 f ( h)! f ( 2h) = 4 f ( 0)! f ( 0) + HOT Solving for the exact solution:! f ( 0) = 4 f ( h)! f ( 2h) + HOT 3 Since the Higher Order Terms (HOT) are at least O(h 3 ), f(0) is a better estimate than either f(h) or f(h 2 ). Similar formulas can be derived for schemes of different orders.! For an p-th order scheme we have:! ( ) = f ( 0) + Ch p + HOT f h similarly, the solution on a finer grid is:! ( ) = f ( 0) + C( h / r) p + HOT f h / r subtracting to eliminate the h n term:! f ( h) f ( h / r)r p = f ( 0) 1 r p ( ) + HOT Solving for the exact solution:! f ( 0) = f ( h) f ( 2h)r p + HOT 1 r p Uncertainty Quantification!

6 In most cases uncertainties do not only come from the numerical solution but also from the problem specification. Those uncertainties include:! Material properties (density, viscosity, etc)! Domain geometry! Boundary conditions! Model assumption! In principle these uncertainties can be treated in the same way as experimental uncertainties.! In practice, the quantification of uncertainties requires us to assume that the error follows a particular distribution and it is easiest to deal with uncorrelated errors.! The identification of the uncertainty in all model and input parameters is challenging and there are considerable questions whether standard uncertainty quantification will ever be able to deal with one-off events or Black Swans. The role of incorrect use of uncertainty models (Black-Scholes, etc) in the recent financial crisis suggests caution!! Validation! Validating a theory consists of comparing its predictions with experimental results. It is thus at the core of science and as such not a computational issue.! However, scientific computing has greatly increased our abilities to solve complex models and this is leading to more and more complex models, with new issues and challenges for validation.! At the present time there is no real theory covering how to validate a computational model, except compare the predictions with experiments or observations for selected cases. For complex models, build by assembling sub-models, the sub-models are usually validated independently.! C.J. Roy. Review of code and solution verification procedures for computational simulation. Journal of Computational Physics 205 (2005) ! AIAA AIAA Guide for the Verification and Validation of Computational Fluid Dynamics Simulations. American Institute of Aeronautics and Astronautics.! Standard for Verification and Validation in and Heat TransferV V !

SYDE 112, LECTURE 7: Integration by Parts

SYDE 112, LECTURE 7: Integration by Parts SYDE 112, LECTURE 7: Integration by Parts 1 Integration By Parts Consider trying to take the integral of xe x dx. We could try to find a substitution but would quickly grow frustrated there is no substitution

More information

Concepts and Practice of Verification, Validation, and Uncertainty Quantification

Concepts and Practice of Verification, Validation, and Uncertainty Quantification Concepts and Practice of Verification, Validation, and Uncertainty Quantification William L. Oberkampf Sandia National Laboratories (retired) Consulting Engineer wloconsulting@gmail.com Austin, Texas Exploratory

More information

Numerical Simulation of Oscillating Fluid Flow in Inertance Tubes

Numerical Simulation of Oscillating Fluid Flow in Inertance Tubes Numerical Simulation of Oscillating Fluid Flow in Inertance Tubes C. Dodson, 2, A. Razani, 2 and T. Roberts Air Force Research Laboratory Kirtland AFB, NM, 877-5776 2 The University of New Mexico Albuquerque,

More information

EXAMPLE OF ONE-STEP METHOD

EXAMPLE OF ONE-STEP METHOD EXAMPLE OF ONE-STEP METHOD Consider solving y = y cos x, y(0) = 1 Imagine writing a Taylor series for the solution Y (x), say initially about x = 0. Then Y (h) = Y (0) + hy (0) + h2 2 Y (0) + h3 6 Y (0)

More information

Lecture 1 Introduction. Essentially all models are wrong, but some are useful, George E.P. Box, Industrial Statistician

Lecture 1 Introduction. Essentially all models are wrong, but some are useful, George E.P. Box, Industrial Statistician Lecture 1 Introduction Essentially all models are wrong, but some are useful, George E.P. Box, Industrial Statistician Lecture 1 Introduction What is validation, verification and uncertainty quantification?

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

Numerical Analysis Exam with Solutions

Numerical Analysis Exam with Solutions Numerical Analysis Exam with Solutions Richard T. Bumby Fall 000 June 13, 001 You are expected to have books, notes and calculators available, but computers of telephones are not to be used during the

More information

Integration Using Tables and Summary of Techniques

Integration Using Tables and Summary of Techniques Integration Using Tables and Summary of Techniques Philippe B. Laval KSU Today Philippe B. Laval (KSU) Summary Today 1 / 13 Introduction We wrap up integration techniques by discussing the following topics:

More information

An Overly Simplified and Brief Review of Differential Equation Solution Methods. 1. Some Common Exact Solution Methods for Differential Equations

An Overly Simplified and Brief Review of Differential Equation Solution Methods. 1. Some Common Exact Solution Methods for Differential Equations An Overly Simplified and Brief Review of Differential Equation Solution Methods We will be dealing with initial or boundary value problems. A typical initial value problem has the form y y 0 y(0) 1 A typical

More information

This practice exam is intended to help you prepare for the final exam for MTH 142 Calculus II.

This practice exam is intended to help you prepare for the final exam for MTH 142 Calculus II. MTH 142 Practice Exam Chapters 9-11 Calculus II With Analytic Geometry Fall 2011 - University of Rhode Island This practice exam is intended to help you prepare for the final exam for MTH 142 Calculus

More information

Introduction to Finite Di erence Methods

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

More information

Second-Order Homogeneous Linear Equations with Constant Coefficients

Second-Order Homogeneous Linear Equations with Constant Coefficients 15 Second-Order Homogeneous Linear Equations with Constant Coefficients A very important class of second-order homogeneous linear equations consists of those with constant coefficients; that is, those

More information

Section 5.5 More Integration Formula (The Substitution Method) 2 Lectures. Dr. Abdulla Eid. College of Science. MATHS 101: Calculus I

Section 5.5 More Integration Formula (The Substitution Method) 2 Lectures. Dr. Abdulla Eid. College of Science. MATHS 101: Calculus I Section 5.5 More Integration Formula (The Substitution Method) 2 Lectures College of Science MATHS : Calculus I (University of Bahrain) Integrals / 7 The Substitution Method Idea: To replace a relatively

More information

A Multilevel Method for Solution Verification

A Multilevel Method for Solution Verification A Multilevel Method for Solution Verification Marc Garbey and Christophe Picard University of Houston, Computer Science (http://www.cs.uh.edu/~garbey/) Summary. This paper addresses the challenge of solution

More information

Calculus I Practice Problems 8: Answers

Calculus I Practice Problems 8: Answers Calculus I Practice Problems : Answers. Let y x x. Find the intervals in which the function is increasing and decreasing, and where it is concave up and concave down. Sketch the graph. Answer. Differentiate

More information

MA2501 Numerical Methods Spring 2015

MA2501 Numerical Methods Spring 2015 Norwegian University of Science and Technology Department of Mathematics MA2501 Numerical Methods Spring 2015 Solutions to exercise set 7 1 Cf. Cheney and Kincaid, Exercise 4.1.9 Consider the data points

More information

Uncertainty quantification of modeling and simulation for reliability certification

Uncertainty quantification of modeling and simulation for reliability certification Advances in Fluid Mechanics X 5 ncertainty quantification of modeling and simulation for reliability certification Zhibo Ma & Ming Yu Institute of Applied Physics and Computational Mathematics, China Abstract

More information

Richardson Extrapolation-based Discretization Uncertainty Estimation for Computational Fluid Dynamics

Richardson Extrapolation-based Discretization Uncertainty Estimation for Computational Fluid Dynamics Accepted in ASME Journal of Fluids Engineering, 2014 Richardson Extrapolation-based Discretization Uncertainty Estimation for Computational Fluid Dynamics Tyrone S. Phillips Graduate Research Assistant

More information

Verification and validation in computational fluid dynamics

Verification and validation in computational fluid dynamics Progress in Aerospace Sciences 38 (2002) 209 272 Verification and validation in computational fluid dynamics William L. Oberkampf a, *, Timothy G. Trucano b a Validation and Uncertainty Estimation Department,

More information

Calculus. Integration (III)

Calculus. Integration (III) Calculus Integration (III) Outline 1 Other Techniques of Integration Partial Fractions Integrals Involving Powers of Trigonometric Functions Trigonometric Substitution 2 Using Tables of Integrals Integration

More information

Section x7 +

Section x7 + Difference Equations to Differential Equations Section 5. Polynomial Approximations In Chapter 3 we discussed the problem of finding the affine function which best approximates a given function about some

More information

COMPLETED RICHARDSON EXTRAPOLATION IN SPACE AND TIME

COMPLETED RICHARDSON EXTRAPOLATION IN SPACE AND TIME COMMUNICATIONS IN NUMERICAL METHODS IN ENGINEERING, Vol. 13, 573±582 (1997) COMPLETED RICHARDSON EXTRAPOLATION IN SPACE AND TIME SHANE A. RICHARDS Department of Applied Mathematics, The University of Adelaide,

More information

MATH 1231 MATHEMATICS 1B Calculus Section 4.4: Taylor & Power series.

MATH 1231 MATHEMATICS 1B Calculus Section 4.4: Taylor & Power series. MATH 1231 MATHEMATICS 1B 2010. For use in Dr Chris Tisdell s lectures. Calculus Section 4.4: Taylor & Power series. 1. What is a Taylor series? 2. Convergence of Taylor series 3. Common Maclaurin series

More information

Math 106 Fall 2014 Exam 2.1 October 31, ln(x) x 3 dx = 1. 2 x 2 ln(x) + = 1 2 x 2 ln(x) + 1. = 1 2 x 2 ln(x) 1 4 x 2 + C

Math 106 Fall 2014 Exam 2.1 October 31, ln(x) x 3 dx = 1. 2 x 2 ln(x) + = 1 2 x 2 ln(x) + 1. = 1 2 x 2 ln(x) 1 4 x 2 + C Math 6 Fall 4 Exam. October 3, 4. The following questions have to do with the integral (a) Evaluate dx. Use integration by parts (x 3 dx = ) ( dx = ) x3 x dx = x x () dx = x + x x dx = x + x 3 dx dx =

More information

Lecture 1. MA2730: Analysis I. Lecture slides for MA2730 Analysis I. Functions Level 1 revision. MA2730: topics for Lecture 1

Lecture 1. MA2730: Analysis I. Lecture slides for MA2730 Analysis I. Functions Level 1 revision. MA2730: topics for Lecture 1 Contents of the teaching and assessment blocks MA2730: Analysis I Lecture slides for MA2730 Analysis I Simon people.brunel.ac.uk/~icsrsss simon.shaw@brunel.ac.uk College of Engineering, Design and Physical

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

Limitations of Richardson Extrapolation and Some Possible Remedies

Limitations of Richardson Extrapolation and Some Possible Remedies Ismail Celik 1 Jun Li Gusheng Hu Christian Shaffer Mechanical and Aerospace Engineering Department, West Virginia University, Morgantown, WV 26506-6106 Limitations of Richardson Extrapolation and Some

More information

Chapter 6. Techniques of Integration. 6.1 Differential notation

Chapter 6. Techniques of Integration. 6.1 Differential notation Chapter 6 Techniques of Integration In this chapter, we expand our repertoire for antiderivatives beyond the elementary functions discussed so far. A review of the table of elementary antiderivatives (found

More information

Physics 115/242 Romberg Integration

Physics 115/242 Romberg Integration Physics 5/242 Romberg Integration Peter Young In this handout we will see how, starting from the trapezium rule, we can obtain much more accurate values for the integral by repeatedly eliminating the leading

More information

SYSTEMS OF ODES. mg sin ( (x)) dx 2 =

SYSTEMS OF ODES. mg sin ( (x)) dx 2 = SYSTEMS OF ODES Consider the pendulum shown below. Assume the rod is of neglible mass, that the pendulum is of mass m, and that the rod is of length `. Assume the pendulum moves in the plane shown, and

More information

SESSION 6 Trig. Equations and Identities. Math 30-1 R 3. (Revisit, Review and Revive)

SESSION 6 Trig. Equations and Identities. Math 30-1 R 3. (Revisit, Review and Revive) SESSION 6 Trig. Equations and Identities Math 30-1 R 3 (Revisit, Review and Revive) 1 P a g e 2 P a g e Mathematics 30-1 Learning Outcomes Specific Outcome 5: Solve, algebraically and graphically, first

More information

Chapter 6. Techniques of Integration. 6.1 Differential notation

Chapter 6. Techniques of Integration. 6.1 Differential notation Chapter 6 Techniques of Integration In this chapter, we expand our repertoire for antiderivatives beyond the elementary functions discussed so far. A review of the table of elementary antiderivatives (found

More information

01 Harmonic Oscillations

01 Harmonic Oscillations Utah State University DigitalCommons@USU Foundations of Wave Phenomena Library Digital Monographs 8-2014 01 Harmonic Oscillations Charles G. Torre Department of Physics, Utah State University, Charles.Torre@usu.edu

More information

f(g(x)) g (x) dx = f(u) du.

f(g(x)) g (x) dx = f(u) du. 1. Techniques of Integration Section 8-IT 1.1. Basic integration formulas. Integration is more difficult than derivation. The derivative of every rational function or trigonometric function is another

More information

Math 1310 Final Exam

Math 1310 Final Exam Math 1310 Final Exam December 11, 2014 NAME: INSTRUCTOR: Write neatly and show all your work in the space provided below each question. You may use the back of the exam pages if you need additional space

More information

Time: 1 hour 30 minutes

Time: 1 hour 30 minutes Paper Reference(s) 6666/0 Edexcel GCE Core Mathematics C4 Silver Level S5 Time: hour 0 minutes Materials required for examination papers Mathematical Formulae (Green) Items included with question Nil Candidates

More information

The Big 50 Revision Guidelines for C3

The Big 50 Revision Guidelines for C3 The Big 50 Revision Guidelines for C3 If you can understand all of these you ll do very well 1. Know how to recognise linear algebraic factors, especially within The difference of two squares, in order

More information

Mathematics for Chemists 2 Lecture 14: Fourier analysis. Fourier series, Fourier transform, DFT/FFT

Mathematics for Chemists 2 Lecture 14: Fourier analysis. Fourier series, Fourier transform, DFT/FFT Mathematics for Chemists 2 Lecture 14: Fourier analysis Fourier series, Fourier transform, DFT/FFT Johannes Kepler University Summer semester 2012 Lecturer: David Sevilla Fourier analysis 1/25 Remembering

More information

Method of manufactured solutions applied to variable-density flow solvers

Method of manufactured solutions applied to variable-density flow solvers Center for Turbulence Research Annual Research Briefs 2007 155 Method of manufactured solutions applied to variable-density flow solvers By L. Shunn AND F. Ham 1. Motivation and objectives The term verification,

More information

Jim Lambers MAT 460/560 Fall Semester Practice Final Exam

Jim Lambers MAT 460/560 Fall Semester Practice Final Exam Jim Lambers MAT 460/560 Fall Semester 2009-10 Practice Final Exam 1. Let f(x) = sin 2x + cos 2x. (a) Write down the 2nd Taylor polynomial P 2 (x) of f(x) centered around x 0 = 0. (b) Write down the corresponding

More information

Romberg Integration. MATH 375 Numerical Analysis. J. Robert Buchanan. Spring Department of Mathematics

Romberg Integration. MATH 375 Numerical Analysis. J. Robert Buchanan. Spring Department of Mathematics Romberg Integration MATH 375 Numerical Analysis J. Robert Buchanan Department of Mathematics Spring 019 Objectives and Background In this lesson we will learn to obtain high accuracy approximations to

More information

Convergence of sequences and series

Convergence of sequences and series Convergence of sequences and series A sequence f is a map from N the positive integers to a set. We often write the map outputs as f n rather than f(n). Often we just list the outputs in order and leave

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

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation Lecture slides based on the textbook Scientific Computing: An Introductory Survey by Michael T. Heath, copyright c 2018 by the Society for Industrial and Applied Mathematics. http://www.siam.org/books/cl80

More information

Taylor series. Chapter Introduction From geometric series to Taylor polynomials

Taylor series. Chapter Introduction From geometric series to Taylor polynomials Chapter 2 Taylor series 2. Introduction The topic of this chapter is find approximations of functions in terms of power series, also called Taylor series. Such series can be described informally as infinite

More information

Improving the Verification and Validation Process

Improving the Verification and Validation Process Improving the Verification and Validation Process Mike Fagan Rice University Dave Higdon Los Alamos National Laboratory Notes to Audience I will use the much shorter VnV abbreviation, rather than repeat

More information

A Complete Framework for Verification, Validation, and Uncertainty Quantification in Scientific Computing (Invited)

A Complete Framework for Verification, Validation, and Uncertainty Quantification in Scientific Computing (Invited) 48th AIAA Aerospace Sciences Meeting Including the New Horizons Forum and Aerospace Exposition 4-7 January 2010, Orlando, Florida AIAA 2010-124 A Complete Framework for Verification, Validation, and Uncertainty

More information

1. Method 1: bisection. The bisection methods starts from two points a 0 and b 0 such that

1. Method 1: bisection. The bisection methods starts from two points a 0 and b 0 such that Chapter 4 Nonlinear equations 4.1 Root finding Consider the problem of solving any nonlinear relation g(x) = h(x) in the real variable x. We rephrase this problem as one of finding the zero (root) of a

More information

November 20, Interpolation, Extrapolation & Polynomial Approximation

November 20, Interpolation, Extrapolation & Polynomial Approximation Interpolation, Extrapolation & Polynomial Approximation November 20, 2016 Introduction In many cases we know the values of a function f (x) at a set of points x 1, x 2,..., x N, but we don t have the analytic

More information

10.7 Trigonometric Equations and Inequalities

10.7 Trigonometric Equations and Inequalities 0.7 Trigonometric Equations and Inequalities 857 0.7 Trigonometric Equations and Inequalities In Sections 0. 0. and most recently 0. we solved some basic equations involving the trigonometric functions.

More information

MB4018 Differential equations

MB4018 Differential equations MB4018 Differential equations Part II http://www.staff.ul.ie/natalia/mb4018.html Prof. Natalia Kopteva Spring 2015 MB4018 (Spring 2015) Differential equations Part II 0 / 69 Section 1 Second-Order Linear

More information

Study # 1 11, 15, 19

Study # 1 11, 15, 19 Goals: 1. Recognize Taylor Series. 2. Recognize the Maclaurin Series. 3. Derive Taylor series and Maclaurin series representations for known functions. Study 11.10 # 1 11, 15, 19 f (n) (c)(x c) n f(c)+

More information

TAYLOR SERIES [SST 8.8]

TAYLOR SERIES [SST 8.8] TAYLOR SERIES [SST 8.8] TAYLOR SERIES: Every function f C (c R, c + R) has a unique Taylor series about x = c of the form: f (k) (c) f(x) = (x c) k = f(c) + f (c) (x c) + f (c) (x c) 2 + f (c) (x c) 3

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

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

MECH 314 Dynamics of Mechanisms February 17, 2011 Offset Slider Crank Analysis and Some Other Slider Systems

MECH 314 Dynamics of Mechanisms February 17, 2011 Offset Slider Crank Analysis and Some Other Slider Systems MCH 314 ynamics of Mechanisms February 17, 011 ffset Slider Crank nalysis and Some ther Slider Systems 1 ffset Slider Crank Position nalysis Position and velocity analysis for the common slider-crank has

More information

Lecture Notes for Math 251: ODE and PDE. Lecture 30: 10.1 Two-Point Boundary Value Problems

Lecture Notes for Math 251: ODE and PDE. Lecture 30: 10.1 Two-Point Boundary Value Problems Lecture Notes for Math 251: ODE and PDE. Lecture 30: 10.1 Two-Point Boundary Value Problems Shawn D. Ryan Spring 2012 Last Time: We finished Chapter 9: Nonlinear Differential Equations and Stability. Now

More information

Direct Modeling for Computational Fluid Dynamics

Direct Modeling for Computational Fluid Dynamics Direct Modeling for Computational Fluid Dynamics Kun Xu February 20, 2013 Computational fluid dynamics (CFD) is new emerging scientific discipline, and targets to simulate fluid motion in different scales.

More information

Section 5.6. Integration By Parts. MATH 126 (Section 5.6) Integration By Parts The University of Kansas 1 / 10

Section 5.6. Integration By Parts. MATH 126 (Section 5.6) Integration By Parts The University of Kansas 1 / 10 Section 5.6 Integration By Parts MATH 126 (Section 5.6) Integration By Parts The University of Kansas 1 / 10 Integration By Parts Manipulating the Product Rule d dx (f (x) g(x)) = f (x) g (x) + f (x) g(x)

More information

AN UNCERTAINTY ESTIMATION EXAMPLE FOR BACKWARD FACING STEP CFD SIMULATION. Abstract

AN UNCERTAINTY ESTIMATION EXAMPLE FOR BACKWARD FACING STEP CFD SIMULATION. Abstract nd Workshop on CFD Uncertainty Analysis - Lisbon, 19th and 0th October 006 AN UNCERTAINTY ESTIMATION EXAMPLE FOR BACKWARD FACING STEP CFD SIMULATION Alfredo Iranzo 1, Jesús Valle, Ignacio Trejo 3, Jerónimo

More information

Coordinate systems and vectors in three spatial dimensions

Coordinate systems and vectors in three spatial dimensions PHYS2796 Introduction to Modern Physics (Spring 2015) Notes on Mathematics Prerequisites Jim Napolitano, Department of Physics, Temple University January 7, 2015 This is a brief summary of material on

More information

CHAPTER 5. Higher Order Linear ODE'S

CHAPTER 5. Higher Order Linear ODE'S A SERIES OF CLASS NOTES FOR 2005-2006 TO INTRODUCE LINEAR AND NONLINEAR PROBLEMS TO ENGINEERS, SCIENTISTS, AND APPLIED MATHEMATICIANS DE CLASS NOTES 2 A COLLECTION OF HANDOUTS ON SCALAR LINEAR ORDINARY

More information

8.7 Taylor s Inequality Math 2300 Section 005 Calculus II. f(x) = ln(1 + x) f(0) = 0

8.7 Taylor s Inequality Math 2300 Section 005 Calculus II. f(x) = ln(1 + x) f(0) = 0 8.7 Taylor s Inequality Math 00 Section 005 Calculus II Name: ANSWER KEY Taylor s Inequality: If f (n+) is continuous and f (n+) < M between the center a and some point x, then f(x) T n (x) M x a n+ (n

More information

Review: Power series define functions. Functions define power series. Taylor series of a function. Taylor polynomials of a function.

Review: Power series define functions. Functions define power series. Taylor series of a function. Taylor polynomials of a function. Taylor Series (Sect. 10.8) Review: Power series define functions. Functions define power series. Taylor series of a function. Taylor polynomials of a function. Review: Power series define functions Remarks:

More information

Homework Solutions: , plus Substitutions

Homework Solutions: , plus Substitutions Homework Solutions: 2.-2.2, plus Substitutions Section 2. I have not included any drawings/direction fields. We can see them using Maple or by hand, so we ll be focusing on getting the analytic solutions

More information

Finite difference models: one dimension

Finite difference models: one dimension Chapter 6 Finite difference models: one dimension 6.1 overview Our goal in building numerical models is to represent differential equations in a computationally manageable way. A large class of numerical

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

11.5. The Chain Rule. Introduction. Prerequisites. Learning Outcomes

11.5. The Chain Rule. Introduction. Prerequisites. Learning Outcomes The Chain Rule 11.5 Introduction In this Section we will see how to obtain the derivative of a composite function (often referred to as a function of a function ). To do this we use the chain rule. This

More information

10.7 Trigonometric Equations and Inequalities

10.7 Trigonometric Equations and Inequalities 0.7 Trigonometric Equations and Inequalities 857 0.7 Trigonometric Equations and Inequalities In Sections 0., 0. and most recently 0., we solved some basic equations involving the trigonometric functions.

More information

n=1 ( 2 3 )n (a n ) converges by direct comparison to

n=1 ( 2 3 )n (a n ) converges by direct comparison to . (a) n = a n converges, so we know that a n =. Therefore, for n large enough we know that a n

More information

9709 MATHEMATICS. 9709/33 Paper 3, maximum raw mark 75

9709 MATHEMATICS. 9709/33 Paper 3, maximum raw mark 75 CAMBRIDGE INTERNATIONAL EXAMINATIONS GCE Advanced Level MARK SCHEME for the May/June 04 series 9709 MATHEMATICS 9709/ Paper, maximum raw mark 75 This mark scheme is published as an aid to teachers and

More information

Section 5.8. Taylor Series

Section 5.8. Taylor Series Difference Equations to Differential Equations Section 5.8 Taylor Series In this section we will put together much of the work of Sections 5.-5.7 in the context of a discussion of Taylor series. We begin

More information

Numerical Solutions of Boundary Value Problems

Numerical Solutions of Boundary Value Problems Numerical Solutions of Boundary Value Problems In these note we will consider the solution to boundary value problems of the form y = f(x,y,y ), a < x < b, () y(a) = A, (2) y(b) = B. (3) We will consider

More information

TAYLOR POLYNOMIALS DARYL DEFORD

TAYLOR POLYNOMIALS DARYL DEFORD TAYLOR POLYNOMIALS DARYL DEFORD 1. Introduction We have seen in class that Taylor polynomials provide us with a valuable tool for approximating many different types of functions. However, in order to really

More information

Transformation of Probability Densities

Transformation of Probability Densities Transformation of Probability Densities This Wikibook shows how to transform the probability density of a continuous random variable in both the one-dimensional and multidimensional case. In other words,

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

APPLICATIONS OF DIFFERENTIATION

APPLICATIONS OF DIFFERENTIATION 4 APPLICATIONS OF DIFFERENTIATION APPLICATIONS OF DIFFERENTIATION The method we used to sketch curves in Section 4.5 was a culmination of much of our study of differential calculus. The graph was the final

More information

MATH 320, WEEK 11: Eigenvalues and Eigenvectors

MATH 320, WEEK 11: Eigenvalues and Eigenvectors MATH 30, WEEK : Eigenvalues and Eigenvectors Eigenvalues and Eigenvectors We have learned about several vector spaces which naturally arise from matrix operations In particular, we have learned about the

More information

6 Lecture 6b: the Euler Maclaurin formula

6 Lecture 6b: the Euler Maclaurin formula Queens College, CUNY, Department of Computer Science Numerical Methods CSCI 361 / 761 Fall 217 Instructor: Dr. Sateesh Mane c Sateesh R. Mane 217 March 26, 218 6 Lecture 6b: the Euler Maclaurin formula

More information

Linear Algebra. and

Linear Algebra. and Instructions Please answer the six problems on your own paper. These are essay questions: you should write in complete sentences. 1. Are the two matrices 1 2 2 1 3 5 2 7 and 1 1 1 4 4 2 5 5 2 row equivalent?

More information

Ma 530 Power Series II

Ma 530 Power Series II Ma 530 Power Series II Please note that there is material on power series at Visual Calculus. Some of this material was used as part of the presentation of the topics that follow. Operations on Power Series

More information

Elementary Linear Algebra

Elementary Linear Algebra Matrices J MUSCAT Elementary Linear Algebra Matrices Definition Dr J Muscat 2002 A matrix is a rectangular array of numbers, arranged in rows and columns a a 2 a 3 a n a 2 a 22 a 23 a 2n A = a m a mn We

More information

8 A pseudo-spectral solution to the Stokes Problem

8 A pseudo-spectral solution to the Stokes Problem 8 A pseudo-spectral solution to the Stokes Problem 8.1 The Method 8.1.1 Generalities We are interested in setting up a pseudo-spectral method for the following Stokes Problem u σu p = f in Ω u = 0 in Ω,

More information

CHAPTER 13 Numerical differentiation of functions of two variables

CHAPTER 13 Numerical differentiation of functions of two variables CHAPTER 13 Numerical differentiation of functions of two variables So far, most of the functions we have encountered have only depended on one variable, but both within mathematics and in applications

More information

FIXED POINT ITERATION

FIXED POINT ITERATION FIXED POINT ITERATION The idea of the fixed point iteration methods is to first reformulate a equation to an equivalent fixed point problem: f (x) = 0 x = g(x) and then to use the iteration: with an initial

More information

8.8 Applications of Taylor Polynomials

8.8 Applications of Taylor Polynomials 8.8 Applications of Taylor Polynomials Mark Woodard Furman U Spring 2008 Mark Woodard (Furman U) 8.8 Applications of Taylor Polynomials Spring 2008 1 / 14 Outline 1 Point estimation 2 Estimation on an

More information

Section 4.8 Anti Derivative and Indefinite Integrals 2 Lectures. Dr. Abdulla Eid. College of Science. MATHS 101: Calculus I

Section 4.8 Anti Derivative and Indefinite Integrals 2 Lectures. Dr. Abdulla Eid. College of Science. MATHS 101: Calculus I Section 4.8 Anti Derivative and Indefinite Integrals 2 Lectures College of Science MATHS 101: Calculus I (University of Bahrain) 1 / 28 Indefinite Integral Given a function f, if F is a function such that

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

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems P.-O. Persson and J. Peraire Massachusetts Institute of Technology 2006 AIAA Aerospace Sciences Meeting, Reno, Nevada January 9,

More information

Mathematical Models with Maple

Mathematical Models with Maple Algebraic Biology 005 151 Mathematical Models with Maple Tetsu YAMAGUCHI Applied System nd Division, Cybernet Systems Co., Ltd., Otsuka -9-3, Bunkyo-ku, Tokyo 11-001, Japan tetsuy@cybernet.co.jp Abstract

More information

JUST THE MATHS UNIT NUMBER DIFFERENTIATION APPLICATIONS 5 (Maclaurin s and Taylor s series) A.J.Hobson

JUST THE MATHS UNIT NUMBER DIFFERENTIATION APPLICATIONS 5 (Maclaurin s and Taylor s series) A.J.Hobson JUST THE MATHS UNIT NUMBER.5 DIFFERENTIATION APPLICATIONS 5 (Maclaurin s and Taylor s series) by A.J.Hobson.5. Maclaurin s series.5. Standard series.5.3 Taylor s series.5.4 Exercises.5.5 Answers to exercises

More information

In July: Complete the Unit 01- Algebraic Essentials Video packet (print template or take notes on loose leaf)

In July: Complete the Unit 01- Algebraic Essentials Video packet (print template or take notes on loose leaf) Hello Advanced Algebra Students In July: Complete the Unit 01- Algebraic Essentials Video packet (print template or take notes on loose leaf) The link to the video is here: https://www.youtube.com/watch?v=yxy4tamxxro

More information

Application of Grid Convergence Index Estimation for Uncertainty Quantification in V&V of Multidimensional Thermal-Hydraulic Simulation

Application of Grid Convergence Index Estimation for Uncertainty Quantification in V&V of Multidimensional Thermal-Hydraulic Simulation The ASME Verification and Validation Symposium (V&V05) May 3-5, Las Vegas, Nevada, USA Application of Grid Convergence Index Estimation for Uncertainty Quantification in V&V of Multidimensional Thermal-Hydraulic

More information

Differentiation by taking logarithms

Differentiation by taking logarithms Differentiation by taking logarithms In this unit we look at how we can use logarithms to simplify certain functions before we differentiate them. In order to master the techniques explained here it is

More information

Homework #4 Solutions

Homework #4 Solutions Homework #4 Solutions 1. f(x) = e x + e 1+sin(x) + cos (x) f (x) = e x + cos(x) e 1+sin(x) sin (x) f (x) = e x + e 1+sin(x) (cos (x) sin(x)) cos (x) f (x) = (1 3e 1+sin(x) cos(x)) sin(x) + e 1+sin(x) (cos

More information

2.2 Separable Equations

2.2 Separable Equations 82 2.2 Separable Equations An equation y = f(x, y) is called separable provided algebraic operations, usually multiplication, division and factorization, allow it to be written in a separable form y =

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 Methods in Physics and Astrophysics

Numerical Methods in Physics and Astrophysics Kostas Kokkotas 2 November 6, 2007 2 kostas.kokkotas@uni-tuebingen.de http://www.tat.physik.uni-tuebingen.de/kokkotas Kostas Kokkotas 3 Error Analysis Definition : Suppose that x is an approximation to

More information

Chapter 2: Differentiation

Chapter 2: Differentiation Chapter 2: Differentiation Spring 2018 Department of Mathematics Hong Kong Baptist University 1 / 82 2.1 Tangent Lines and Their Slopes This section deals with the problem of finding a straight line L

More information

Part 1. The simple harmonic oscillator and the wave equation

Part 1. The simple harmonic oscillator and the wave equation Part 1 The simple harmonic oscillator and the wave equation In the first part of the course we revisit the simple harmonic oscillator, previously discussed in di erential equations class. We use the discussion

More information