5 Ordinary Differential Equations: Finite Difference Methods for Boundary Problems

Size: px
Start display at page:

Download "5 Ordinary Differential Equations: Finite Difference Methods for Boundary Problems"

Transcription

1 5 Ordinary Differential Equations: Finite Difference Metods for Boundary Problems Read sections 10.1, 10.2, 10.4 Review questions , , Introduction In te previous capters we investigated initial value problems: A process or a state was described by a system of ordinary differential equations y f t y t t 0 T y t m Te general solution of suc a problems contains m constants of integration wic were defined by imposing additional conditions at te point t 0, y i t 0 y 0 i i 1 m or, in vector notation, y t 0 For example, consider te scalar second-order equation u t u u If we transform tis equation to te equivalent first-order system, we obtain a system of two equations, u y u f y t y 2 t y 1 y 2 Te initial values become u t 0 y 0 u 0 u t 0 Instead of determining te two constants of integration in tis way one could equally well require two different conditions, for instance, u t 0 α u T Since tere is no qualitative difference between te two boundary points any longer, we will use a more suggestive notation: a t 0 and b T. A problem of te type u t u u t u a α u b 1 ū 0 β a b β

2 is called a (two point) boundary value problem, because te additional conditions for determining te constants of integration are given at te boundary of te domain of definition Ω a b. We know already tat first-order systems of differential equations include iger order equations as a special case. Terefore, te most general form of a boundary value problem is given by y f t y t g y a y b a b 0 Since boundary value problems very often appear in te form of second-order equations, we will investigate only suc systems in te following Two Examples A Stationary Heat Equation We investigate te temperature distribution in a long and tin rod wit lengt L and a constant cross section. Assume tat te eat transfer properties are independent of te position. Distributed over te rod is a eat source. In te equilibrium state, te differential equation ku q x x 0 L olds true, were u x describes te temperature of te rod at point x. If we fix te temperature at te two endpoints at T 0 and T L, respectively, we obtain te boundary conditions u 0 T 0 u L Deformation of a Beam A beam wit lengt L rests at its two ends in fixed positions. A distributed force is applied to te bar. Te deformation y x of te bar from its rest position can be describes by a system of two second-order differential equations, d 2 M dx 2 f x d 2 y M x dx 2 EI were M x is te bending moment, and E and I are constants (te elasticity module and te surface moment of inertia, respectively). Te boundary conditions are M 0 y Existence and Uniqueness of Solutions M L y L Tere is a fundamental difference between initial and boundary value problems wic is important for bot te teoretical investigation and te numerical approximation. Assume tat te 0 0 T L 2

3 rigt-and side f of te differential equation is smoot enoug (for example continuously differentiable 1 ), ten te solution of te initial value problem always exists and is unique at least over sufficient small time intervals. Suc a property does no longer old for boundary value problems. Te following two examples illustrate some possibilities. Example 5.1. Consider te boundary value problem subject to te boundary conditions u u t u 0 0 u b Te general solution of te ordinary differential equation satisfying u 0 0 is u t csint for any constant c. If b is an integer multiple of π, ten csinb 0 for any c, so tere are infinitely many solutions of te boundary value problem if β 0, but tere is no solution if β 0. Example 5.2. Te problem as two solutions of te form were θ satisfies u t u e u 1 0 t u 0 u 1 0 b β ln cos t 1 2 θ 2 cos θ 4 θ 2ecos θ 4 Tis nonlinear equation as exactly two solutions for θ. Te corresponding solutions are plotted in Figure Finite Difference Metods for Linear Problems Discretization A second-order ordinary differential equation u t u u is called linear if te equation as te form u b t u c t u d t Nonlinear problems will be investigated in later capters. In te beginning we assume tat b t 0 t a b 1 Tis requirement is a severe restriction in practice. Fortunately, it can be considerably relaxed. 3

4 Figure 1: Te two solutions of te problem in Example 5.2 Te boundary conditions are u 0 α u b β We coose a step size and subdivide te interval a b into n 1 subintervals I i t i t i 1 for i 0 n suc tat t i a i i 0 n 1 b a n 1 Te points t i are called grid points or nodes. t 0 a and t n 1 b are te boundary nodes. Exactly as before we try to approximate te exact solution u t i by values u i wic are derived by finite difference approximations. In order to obtain an approximation of te second derivative we start by approximating te first derivative: Te next step is Using te abbreviations c i u t i u t i u t i c t i and d i 1 2 u t i 1 2u t i 2 u t i u t i 1 2 u t i 1 u t i u t i 2 u t i 2 u t i 1 2u t i u t i 1 2 d t i we obtain u t i 1 c i u t i 4 d i i 1 n

5 Te numerical approximation is obtained by replacing te approximation sign by an equality sign: u i 1 2u i u i 1 c i 2 u i 2 d i i 1 n Note tat we multiplied troug te equation by 2. It is more tan only convention tat te minus sign is used in tis transformation. Te remaining unknowns are simply obtained by applying te boundary conditions, u 0 α u n 1 β Finally, we obtain a linear system of equations wic can be conveniently written down in matrix notation: 2 c c A c n 2 u 1 u 2.. u n u If all of te c i s are equal to zero, te resulting matrix becomes 2 d 1 2 d 2. 2 d n 1 2 d n f α β Tis is a matrix wic we will observe in many different applications. So it is wort remembering it carefully! Te system matrix is a tridiagonal matrix. Tis is a very special form of sparse matrices. Te latter notion denotes matrices wic consist almost exclusively of zero entries. It is obvious tat one sould take care of suc a property because tis will save a lot of computation time and memory requirements. Remark 5.1. MATLAB provides many convenient functions for andling sparse matrices. Once tey are instantiated, all standard operators take care of tis special property. I recommend to ave a look at te MATLABexercises sparse matrices (no. 4) of period 1 once again. Te matrix A as also oter very interesting properties: Te matrix is symmetric. If c i 0 for all i 1 n, te matrix is positive definite. If we would not ave multiplied by minus 1 wen deriving te linear system, te matrix would be negative definite (wic is someow inconvenient). 5

6 Te first property is easy to see, wile te proof of te second one requires a little bit of computations. Tere is a small detail wic makes a considerable difference compared to finite difference metods in initial value problems: In initial value problems, te approximations u i could be determined one after te oter in a sequential process. Tis is no longer possible for boundary value problems. One must solve te linear system of equations and obtains te solutions u i simultaneously Discretization Errors and Accuracy As usual we are interested in estimating te global error e i u i u t i and its maximal value e max e i 1 i n Tis is a ard problem. Opposed to tat, it is relatively easy to derive an estimate for te local error L i wic appears if we insert te exact solution into te discrete equations: L i 1 2 u t i 1 2u t i If we use te differential equation u t i L i u t i 1 c t i u t i d t i i 1 n c t i u t i 1 2 u t i 1 2u t i As usual, let us apply te Taylor expansions u t i 1 u t i u t i 2 2 u t i d t i, we obtain te expression u t i 1 u t i 3 6 u t i 4 24 u 4 s i 1 Tis yields 1 L i 12 u 4 τ i 2 τ i t i 1 t i 1 Te problem consists now of deriving a relation between te local and te global error. Tis can be done by subtracting te two equations from eac oter: 1 2 u i 1 2u i 1 2 u t i 1 2u t i u t i 1 c i u t i 1 2 e i 1 2e i e i 1 c i e i 6 u i 1 c i u i L i i d i d i L i 1 n

7 Here, we ave used te definition e i u i u t i. Multiplication by 2 yields e i 1 2 c i 2 e i e i 1 2 L i i 1 n Because te values for u 0 and u n 1 are exact, we ave e 0 e n 1 0. Summarizing we obtain te linear system of equations A e 2 L If te matrix A is nonsingular, it olds Tis gives rise to te estimate e e 2 A 1 2 A 1 L L In order to prove te convergence of te metod one needs to know ow A 1 depends on. Tis estimation is nontrivial. Note tat te dimension of A 1 depends on! Teorem 5.1. If c t 0 for all t a b, ten and, consequently, A 1 e O 2 O 2 Tis means tat te order of discretization and te order of convergence are identical. Note tat te teorem contains a typical stability result: If te perturbations (ere: L ) are small, ten te error of te result (ere: e) remains small. For later considerations, it sould be noted tat κ A A 1 Tis property will be essential in later sections Te Discretization of Convection Terms O 2 Te first-order term b t u in a second-order differential equation u b t u c t u d t is often called te convection term because it very often models pysical convection in a system. We already know finite difference approximation to first-order derivatives, namely, u t i D u t i : u t i u t i 1 7

8 and u t i D u t i : u t i 1 u t i respectively. Tey are called backward and forward finite differences. Moreover, we know tat bot approximations ave only first order of accuracy, D u t i u t i O 1 D u t i u t i O 1 Since we already ave second-order approximations for all oter terms, it would be wise to use a second-order approximation ere, too. Tis can be acieved if we use, for example, te mean between forward and backward differences: D 0 u 1 t i D u t i 2 D u t i u t i 1 u t i 1 2 It is easy to see tat tis central difference as second order (exercise!), D 0 u t i u t i O 2 In a similar manner as above, we obtain te difference equation 1 b i 2 u i 1 2 c i 2 u i Let us introduce te abbreviations p i 2 c i 2 q i Tis gives rise to te linear system of equations p 1 q 2 r 1 p qn A r n 1 p n 1 b i 2 u i 1 1 b i 1 r i 2 u 1 u 2.. u n u d i i b i 1 2 d 1 d n r 0 α 2 d 2. d n 1 q n 1β 2 f 1 n It is very ard to sow te convergence for suc a system. However, one can sow tat A is nonsingular and e O 2 if te continuous problem is uniquely solvable and te step size is sufficiently small. Te latter can really be a serious restriction! 8

9 5.2.4 Oter Boundary Conditions Wen deriving te discrete problem A u ad te form u a f we always assumed tat te boundary conditions α u b Many problems include boundary conditions wic contain derivatives of te solution, for example, u a α Tis is te case in te eat equation if we ave perfectly isolating boundaries or boundaries wic allow for eat transfer. Te discretization of te differential equation for i 1 is r 0 u 0 p 1 u 1 q 2 u 2 2 d 1 Wit te former kind of boundary conditions it was easy to replace te value for u 0 by α. Here, tis is no longer possible since u a must be discretized additionally. One metod can be derived as follows. We write down formally te discretization for i 0, r 1u 1 p 0 u 0 q 1 u 1 2 d 0 and a central discretization for te boundary condition, u 1 u 1 2 u 1 is a fictious value because it does not correspond to any value of te exact solution. But we can eliminate tis value, u 1 u 1 2α suc tat te difference equation, for i 0, becomes 2α p 0 u 0 q 1 u 1 2 d 0 or, equivalently, r 1 u 1 p 0 u 0 r 1 q 1 u 1 α β 2 d 0 2r 1α Tis equation is added to te old system suc tat u 0 can be computed. Te same idea can obviously be applied if te boundary condition at t b reads u b β. In te general case, tis discretization as only first order. But one can sow tat second order is obtained if α 0. Tere are even more general boundary conditions wic contain combinations of function values and values of te derivatives. Te approximation principles of tese conditions are exactly as before. Te following notions are often used to caracterize te different types of boundary conditions: 9

10 notion type example Diriclet fix a function value u a α Neumann fix a derivative value u a α Robin (mixed) linear combination of η 1 u a η 2 u a function values and derivatives α Higer Order metods Tere also exist iger order metods. Tey can be constructed in almost te same way as for finite difference metods using te Runge-Kutta idea or te multistep idea.matlab s solver for two-point boundary value problems is bvp4c. It implements a fourt-order Runge-Kutta metod wit automatic step size control. For second-order scalar boundary value problems it is more common to use multistep discretizations. 5.3 Examples A Simple Problem Consider te problem u 12t 2 t 0 1 u 0 0 u 1 1 Te exact solution is obviously u t t 4. We apply te finite difference metod wit different step sizes and compute te accuracy of te resulting approximation. Te MATLABcode is given on te next page. Te following table contains te results. q denotes te error reduction factor between two successive rows. According to our teory, it sould approac 4 since te metod is of second order. Te results confirm te teory. e q 1/ / / / / / / /

11 clear % Define number of cycles L = 8; l = zeros(l,1); el = zeros(l,1); % Cycle over all gridsizes n = 1; for l = 1:L % Define grid a = 0; b = 1; = (b-a)/(n+1); tv = linspace(a,b,n+2) ; ti = tv(2:end-1); % Define matrix diagonals p = 2*ones(n,1); q = -ones(n,1); r = -ones(n,1); % Define matrix A (Att.: Sparse matrix) A = spdiags([r,p,q],[-1,0,1],n,n); % Rigt-and side vector f = (-ˆ2)*12*ti.ˆ2; % Modify for boundary conditions % f(1) = f(1)+0; f(end) = f(end)+1; % Solve for approximate solution u = A f; % Compute te exact solution uex = ti.ˆ4; % Te error e = norm(u-uex,inf); % Build table l(l) = ; el(l) = e; % Prepare next step n = 2*n+1; end % Results l el q = el(1:end-1)./el(2:end) 11

12 5.3.2 A More Complex Example Te problem is given by te equation 1 t 2 u 2 6t 2 2t cost 1 t 2 sint t 0 1 subject to te boundary conditions u 0 1 u 1 2 sin1 Te rigt-and side and te boundary conditions were cosen in suc a way tat te (unique) exact solution becomes u t t 2 sint 1 Te first step consists of a reformulation of te problem in standard form. By differentiation we obtain wit u 2t 1 t 2 u d t d t 2 6t 2 2t cost 1 t 2 sint Te linear system can be constructed and solved. A compact form of te algoritm can be found on te following page. Te resulting table is given below: e q 1/ / / / / / /

13 clear L = 7; l = zeros(l,1); el = zeros(l,1); n = 3; for l = 1:L a = 0; b = 1; = (b-a)/(n+1); tv = linspace(a,b,n+2) ; ti = tv(2:end-1); p = 2*ones(n,1); % c = 0 b = (/2)*((-2*tv)./(1+tv.ˆ2)); q = -ones(n+2,1)+b; r = -ones(n+2,1)-b; A = spdiags([r(3:end),p,q(1:end-2)],[-1,0,1],n,n); f = (-ˆ2)*((2+6*ti.ˆ2+2*ti.*cos(ti))./(1+ti.ˆ2)-sin(ti)); f(1) = f(1)-r(2)*1; f(end) = f(end)-q(end-1)*(2+sin(1)); u = A f; uex = ti.ˆ2+sin(ti)+1; e = norm(u-uex,inf); l(l) = ; el(l) = e; n = 2*n+1; end l el q = el(1:end-1)./el(2:end) In order to compare tese results wit tose from MATLAB s built-in function bvp4c, we formulated te problem as a first-order system and required a tolerance of 10 7 wic is comparable to te last row of te previous table. Tis code needs only 28 grid points (compared to 256 in our previous attempt) to obtain an accuracy of ! For completeness, te programs are included: 13

14 clear solinit.x = linspace(0,1,11); solinit.y = zeros(2,lengt(solinit.x)); options = bvpset( RelTol,1e-7, AbsTol,1e-7,... BCJacobian,[1,0;0,0],[0,0;1,0], Stats, on ); sol = bvp4c(@funkomp,@bvkomp,solinit,options); tex = sol.x; uex = tex.ˆ2+sin(tex)+1; e = norm(sol.y(1,:)-uex,inf) % % Tis function to be placed in a separate file! function yp = funkomp(t,y) yp = zeros(2,1); yp(2) = -2*t*y(2)/(1+tˆ2)+(2+6*tˆ2+2*t*cos(t))/(1+tˆ2)-sin(t); yp(1) = y(2); % % Tis function to be placed in a separate file! function bv = bvkomp(ya,yb) bv = zeros(2,1); bv(2) = yb(1)-2-sin(1); bv(1) = ya(1)-1; 14

Numerical Differentiation

Numerical Differentiation Numerical Differentiation Finite Difference Formulas for te first derivative (Using Taylor Expansion tecnique) (section 8.3.) Suppose tat f() = g() is a function of te variable, and tat as 0 te function

More information

Consider a function f we ll specify which assumptions we need to make about it in a minute. Let us reformulate the integral. 1 f(x) dx.

Consider a function f we ll specify which assumptions we need to make about it in a minute. Let us reformulate the integral. 1 f(x) dx. Capter 2 Integrals as sums and derivatives as differences We now switc to te simplest metods for integrating or differentiating a function from its function samples. A careful study of Taylor expansions

More information

Polynomial Interpolation

Polynomial Interpolation Capter 4 Polynomial Interpolation In tis capter, we consider te important problem of approximatinga function fx, wose values at a set of distinct points x, x, x,, x n are known, by a polynomial P x suc

More information

The Laplace equation, cylindrically or spherically symmetric case

The Laplace equation, cylindrically or spherically symmetric case Numerisce Metoden II, 7 4, und Übungen, 7 5 Course Notes, Summer Term 7 Some material and exercises Te Laplace equation, cylindrically or sperically symmetric case Electric and gravitational potential,

More information

NUMERICAL DIFFERENTIATION

NUMERICAL DIFFERENTIATION NUMERICAL IFFERENTIATION FIRST ERIVATIVES Te simplest difference formulas are based on using a straigt line to interpolate te given data; tey use two data pints to estimate te derivative. We assume tat

More information

Polynomial Interpolation

Polynomial Interpolation Capter 4 Polynomial Interpolation In tis capter, we consider te important problem of approximating a function f(x, wose values at a set of distinct points x, x, x 2,,x n are known, by a polynomial P (x

More information

Taylor Series and the Mean Value Theorem of Derivatives

Taylor Series and the Mean Value Theorem of Derivatives 1 - Taylor Series and te Mean Value Teorem o Derivatives Te numerical solution o engineering and scientiic problems described by matematical models oten requires solving dierential equations. Dierential

More information

A = h w (1) Error Analysis Physics 141

A = h w (1) Error Analysis Physics 141 Introduction In all brances of pysical science and engineering one deals constantly wit numbers wic results more or less directly from experimental observations. Experimental observations always ave inaccuracies.

More information

How to Find the Derivative of a Function: Calculus 1

How to Find the Derivative of a Function: Calculus 1 Introduction How to Find te Derivative of a Function: Calculus 1 Calculus is not an easy matematics course Te fact tat you ave enrolled in suc a difficult subject indicates tat you are interested in te

More information

The total error in numerical differentiation

The total error in numerical differentiation AMS 147 Computational Metods and Applications Lecture 08 Copyrigt by Hongyun Wang, UCSC Recap: Loss of accuracy due to numerical cancellation A B 3, 3 ~10 16 In calculating te difference between A and

More information

MATH745 Fall MATH745 Fall

MATH745 Fall MATH745 Fall MATH745 Fall 5 MATH745 Fall 5 INTRODUCTION WELCOME TO MATH 745 TOPICS IN NUMERICAL ANALYSIS Instructor: Dr Bartosz Protas Department of Matematics & Statistics Email: bprotas@mcmasterca Office HH 36, Ext

More information

Differential equations. Differential equations

Differential equations. Differential equations Differential equations A differential equation (DE) describes ow a quantity canges (as a function of time, position, ) d - A ball dropped from a building: t gt () dt d S qx - Uniformly loaded beam: wx

More information

2.8 The Derivative as a Function

2.8 The Derivative as a Function .8 Te Derivative as a Function Typically, we can find te derivative of a function f at many points of its domain: Definition. Suppose tat f is a function wic is differentiable at every point of an open

More information

lecture 26: Richardson extrapolation

lecture 26: Richardson extrapolation 43 lecture 26: Ricardson extrapolation 35 Ricardson extrapolation, Romberg integration Trougout numerical analysis, one encounters procedures tat apply some simple approximation (eg, linear interpolation)

More information

Combining functions: algebraic methods

Combining functions: algebraic methods Combining functions: algebraic metods Functions can be added, subtracted, multiplied, divided, and raised to a power, just like numbers or algebra expressions. If f(x) = x 2 and g(x) = x + 2, clearly f(x)

More information

1 The concept of limits (p.217 p.229, p.242 p.249, p.255 p.256) 1.1 Limits Consider the function determined by the formula 3. x since at this point

1 The concept of limits (p.217 p.229, p.242 p.249, p.255 p.256) 1.1 Limits Consider the function determined by the formula 3. x since at this point MA00 Capter 6 Calculus and Basic Linear Algebra I Limits, Continuity and Differentiability Te concept of its (p.7 p.9, p.4 p.49, p.55 p.56). Limits Consider te function determined by te formula f Note

More information

Chapter 5 FINITE DIFFERENCE METHOD (FDM)

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

More information

New Fourth Order Quartic Spline Method for Solving Second Order Boundary Value Problems

New Fourth Order Quartic Spline Method for Solving Second Order Boundary Value Problems MATEMATIKA, 2015, Volume 31, Number 2, 149 157 c UTM Centre for Industrial Applied Matematics New Fourt Order Quartic Spline Metod for Solving Second Order Boundary Value Problems 1 Osama Ala yed, 2 Te

More information

Continuity and Differentiability of the Trigonometric Functions

Continuity and Differentiability of the Trigonometric Functions [Te basis for te following work will be te definition of te trigonometric functions as ratios of te sides of a triangle inscribed in a circle; in particular, te sine of an angle will be defined to be te

More information

Lecture 21. Numerical differentiation. f ( x+h) f ( x) h h

Lecture 21. Numerical differentiation. f ( x+h) f ( x) h h Lecture Numerical differentiation Introduction We can analytically calculate te derivative of any elementary function, so tere migt seem to be no motivation for calculating derivatives numerically. However

More information

Click here to see an animation of the derivative

Click here to see an animation of the derivative Differentiation Massoud Malek Derivative Te concept of derivative is at te core of Calculus; It is a very powerful tool for understanding te beavior of matematical functions. It allows us to optimize functions,

More information

Preface. Here are a couple of warnings to my students who may be here to get a copy of what happened on a day that you missed.

Preface. Here are a couple of warnings to my students who may be here to get a copy of what happened on a day that you missed. Preface Here are my online notes for my course tat I teac ere at Lamar University. Despite te fact tat tese are my class notes, tey sould be accessible to anyone wanting to learn or needing a refreser

More information

Function Composition and Chain Rules

Function Composition and Chain Rules Function Composition and s James K. Peterson Department of Biological Sciences and Department of Matematical Sciences Clemson University Marc 8, 2017 Outline 1 Function Composition and Continuity 2 Function

More information

(4.2) -Richardson Extrapolation

(4.2) -Richardson Extrapolation (.) -Ricardson Extrapolation. Small-O Notation: Recall tat te big-o notation used to define te rate of convergence in Section.: Suppose tat lim G 0 and lim F L. Te function F is said to converge to L as

More information

SECTION 3.2: DERIVATIVE FUNCTIONS and DIFFERENTIABILITY

SECTION 3.2: DERIVATIVE FUNCTIONS and DIFFERENTIABILITY (Section 3.2: Derivative Functions and Differentiability) 3.2.1 SECTION 3.2: DERIVATIVE FUNCTIONS and DIFFERENTIABILITY LEARNING OBJECTIVES Know, understand, and apply te Limit Definition of te Derivative

More information

232 Calculus and Structures

232 Calculus and Structures 3 Calculus and Structures CHAPTER 17 JUSTIFICATION OF THE AREA AND SLOPE METHODS FOR EVALUATING BEAMS Calculus and Structures 33 Copyrigt Capter 17 JUSTIFICATION OF THE AREA AND SLOPE METHODS 17.1 THE

More information

Differentiation in higher dimensions

Differentiation in higher dimensions Capter 2 Differentiation in iger dimensions 2.1 Te Total Derivative Recall tat if f : R R is a 1-variable function, and a R, we say tat f is differentiable at x = a if and only if te ratio f(a+) f(a) tends

More information

Finite Difference Method

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

More information

158 Calculus and Structures

158 Calculus and Structures 58 Calculus and Structures CHAPTER PROPERTIES OF DERIVATIVES AND DIFFERENTIATION BY THE EASY WAY. Calculus and Structures 59 Copyrigt Capter PROPERTIES OF DERIVATIVES. INTRODUCTION In te last capter you

More information

4.2 - Richardson Extrapolation

4.2 - Richardson Extrapolation . - Ricardson Extrapolation. Small-O Notation: Recall tat te big-o notation used to define te rate of convergence in Section.: Definition Let x n n converge to a number x. Suppose tat n n is a sequence

More information

Runge-Kutta methods. With orders of Taylor methods yet without derivatives of f (t, y(t))

Runge-Kutta methods. With orders of Taylor methods yet without derivatives of f (t, y(t)) Runge-Kutta metods Wit orders of Taylor metods yet witout derivatives of f (t, y(t)) First order Taylor expansion in two variables Teorem: Suppose tat f (t, y) and all its partial derivatives are continuous

More information

Copyright c 2008 Kevin Long

Copyright c 2008 Kevin Long Lecture 4 Numerical solution of initial value problems Te metods you ve learned so far ave obtained closed-form solutions to initial value problems. A closedform solution is an explicit algebriac formula

More information

1 Calculus. 1.1 Gradients and the Derivative. Q f(x+h) f(x)

1 Calculus. 1.1 Gradients and the Derivative. Q f(x+h) f(x) Calculus. Gradients and te Derivative Q f(x+) δy P T δx R f(x) 0 x x+ Let P (x, f(x)) and Q(x+, f(x+)) denote two points on te curve of te function y = f(x) and let R denote te point of intersection of

More information

LECTURE 14 NUMERICAL INTEGRATION. Find

LECTURE 14 NUMERICAL INTEGRATION. Find LECTURE 14 NUMERCAL NTEGRATON Find b a fxdx or b a vx ux fx ydy dx Often integration is required. However te form of fx may be suc tat analytical integration would be very difficult or impossible. Use

More information

NUMERICAL DIFFERENTIATION. James T. Smith San Francisco State University. In calculus classes, you compute derivatives algebraically: for example,

NUMERICAL DIFFERENTIATION. James T. Smith San Francisco State University. In calculus classes, you compute derivatives algebraically: for example, NUMERICAL DIFFERENTIATION James T Smit San Francisco State University In calculus classes, you compute derivatives algebraically: for example, f( x) = x + x f ( x) = x x Tis tecnique requires your knowing

More information

3.1 Extreme Values of a Function

3.1 Extreme Values of a Function .1 Etreme Values of a Function Section.1 Notes Page 1 One application of te derivative is finding minimum and maimum values off a grap. In precalculus we were only able to do tis wit quadratics by find

More information

Exam 1 Review Solutions

Exam 1 Review Solutions Exam Review Solutions Please also review te old quizzes, and be sure tat you understand te omework problems. General notes: () Always give an algebraic reason for your answer (graps are not sufficient),

More information

Chapter 4: Numerical Methods for Common Mathematical Problems

Chapter 4: Numerical Methods for Common Mathematical Problems 1 Capter 4: Numerical Metods for Common Matematical Problems Interpolation Problem: Suppose we ave data defined at a discrete set of points (x i, y i ), i = 0, 1,..., N. Often it is useful to ave a smoot

More information

3.4 Worksheet: Proof of the Chain Rule NAME

3.4 Worksheet: Proof of the Chain Rule NAME Mat 1170 3.4 Workseet: Proof of te Cain Rule NAME Te Cain Rule So far we are able to differentiate all types of functions. For example: polynomials, rational, root, and trigonometric functions. We are

More information

Physically Based Modeling: Principles and Practice Implicit Methods for Differential Equations

Physically Based Modeling: Principles and Practice Implicit Methods for Differential Equations Pysically Based Modeling: Principles and Practice Implicit Metods for Differential Equations David Baraff Robotics Institute Carnegie Mellon University Please note: Tis document is 997 by David Baraff

More information

Section 2.7 Derivatives and Rates of Change Part II Section 2.8 The Derivative as a Function. at the point a, to be. = at time t = a is

Section 2.7 Derivatives and Rates of Change Part II Section 2.8 The Derivative as a Function. at the point a, to be. = at time t = a is Mat 180 www.timetodare.com Section.7 Derivatives and Rates of Cange Part II Section.8 Te Derivative as a Function Derivatives ( ) In te previous section we defined te slope of te tangent to a curve wit

More information

Chapter 8. Numerical Solution of Ordinary Differential Equations. Module No. 2. Predictor-Corrector Methods

Chapter 8. Numerical Solution of Ordinary Differential Equations. Module No. 2. Predictor-Corrector Methods Numerical Analysis by Dr. Anita Pal Assistant Professor Department of Matematics National Institute of Tecnology Durgapur Durgapur-7109 email: anita.buie@gmail.com 1 . Capter 8 Numerical Solution of Ordinary

More information

A h u h = f h. 4.1 The CoarseGrid SystemandtheResidual Equation

A h u h = f h. 4.1 The CoarseGrid SystemandtheResidual Equation Capter Grid Transfer Remark. Contents of tis capter. Consider a grid wit grid size and te corresponding linear system of equations A u = f. Te summary given in Section 3. leads to te idea tat tere migt

More information

Simulation and verification of a plate heat exchanger with a built-in tap water accumulator

Simulation and verification of a plate heat exchanger with a built-in tap water accumulator Simulation and verification of a plate eat excanger wit a built-in tap water accumulator Anders Eriksson Abstract In order to test and verify a compact brazed eat excanger (CBE wit a built-in accumulation

More information

5.1 We will begin this section with the definition of a rational expression. We

5.1 We will begin this section with the definition of a rational expression. We Basic Properties and Reducing to Lowest Terms 5.1 We will begin tis section wit te definition of a rational epression. We will ten state te two basic properties associated wit rational epressions and go

More information

2.3 Product and Quotient Rules

2.3 Product and Quotient Rules .3. PRODUCT AND QUOTIENT RULES 75.3 Product and Quotient Rules.3.1 Product rule Suppose tat f and g are two di erentiable functions. Ten ( g (x)) 0 = f 0 (x) g (x) + g 0 (x) See.3.5 on page 77 for a proof.

More information

The Verlet Algorithm for Molecular Dynamics Simulations

The Verlet Algorithm for Molecular Dynamics Simulations Cemistry 380.37 Fall 2015 Dr. Jean M. Standard November 9, 2015 Te Verlet Algoritm for Molecular Dynamics Simulations Equations of motion For a many-body system consisting of N particles, Newton's classical

More information

Sin, Cos and All That

Sin, Cos and All That Sin, Cos and All Tat James K. Peterson Department of Biological Sciences and Department of Matematical Sciences Clemson University Marc 9, 2017 Outline Sin, Cos and all tat! A New Power Rule Derivatives

More information

Lecture 15. Interpolation II. 2 Piecewise polynomial interpolation Hermite splines

Lecture 15. Interpolation II. 2 Piecewise polynomial interpolation Hermite splines Lecture 5 Interpolation II Introduction In te previous lecture we focused primarily on polynomial interpolation of a set of n points. A difficulty we observed is tat wen n is large, our polynomial as to

More information

Flavius Guiaş. X(t + h) = X(t) + F (X(s)) ds.

Flavius Guiaş. X(t + h) = X(t) + F (X(s)) ds. Numerical solvers for large systems of ordinary differential equations based on te stocastic direct simulation metod improved by te and Runge Kutta principles Flavius Guiaş Abstract We present a numerical

More information

Exercises for numerical differentiation. Øyvind Ryan

Exercises for numerical differentiation. Øyvind Ryan Exercises for numerical differentiation Øyvind Ryan February 25, 2013 1. Mark eac of te following statements as true or false. a. Wen we use te approximation f (a) (f (a +) f (a))/ on a computer, we can

More information

WYSE Academic Challenge 2004 Sectional Mathematics Solution Set

WYSE Academic Challenge 2004 Sectional Mathematics Solution Set WYSE Academic Callenge 00 Sectional Matematics Solution Set. Answer: B. Since te equation can be written in te form x + y, we ave a major 5 semi-axis of lengt 5 and minor semi-axis of lengt. Tis means

More information

AMS 147 Computational Methods and Applications Lecture 09 Copyright by Hongyun Wang, UCSC. Exact value. Effect of round-off error.

AMS 147 Computational Methods and Applications Lecture 09 Copyright by Hongyun Wang, UCSC. Exact value. Effect of round-off error. Lecture 09 Copyrigt by Hongyun Wang, UCSC Recap: Te total error in numerical differentiation fl( f ( x + fl( f ( x E T ( = f ( x Numerical result from a computer Exact value = e + f x+ Discretization error

More information

Pre-Calculus Review Preemptive Strike

Pre-Calculus Review Preemptive Strike Pre-Calculus Review Preemptive Strike Attaced are some notes and one assignment wit tree parts. Tese are due on te day tat we start te pre-calculus review. I strongly suggest reading troug te notes torougly

More information

The Priestley-Chao Estimator

The Priestley-Chao Estimator Te Priestley-Cao Estimator In tis section we will consider te Pristley-Cao estimator of te unknown regression function. It is assumed tat we ave a sample of observations (Y i, x i ), i = 1,..., n wic are

More information

Math Spring 2013 Solutions to Assignment # 3 Completion Date: Wednesday May 15, (1/z) 2 (1/z 1) 2 = lim

Math Spring 2013 Solutions to Assignment # 3 Completion Date: Wednesday May 15, (1/z) 2 (1/z 1) 2 = lim Mat 311 - Spring 013 Solutions to Assignment # 3 Completion Date: Wednesday May 15, 013 Question 1. [p 56, #10 (a)] 4z Use te teorem of Sec. 17 to sow tat z (z 1) = 4. We ave z 4z (z 1) = z 0 4 (1/z) (1/z

More information

7 Semiparametric Methods and Partially Linear Regression

7 Semiparametric Methods and Partially Linear Regression 7 Semiparametric Metods and Partially Linear Regression 7. Overview A model is called semiparametric if it is described by and were is nite-dimensional (e.g. parametric) and is in nite-dimensional (nonparametric).

More information

Analytic Functions. Differentiable Functions of a Complex Variable

Analytic Functions. Differentiable Functions of a Complex Variable Analytic Functions Differentiable Functions of a Complex Variable In tis capter, we sall generalize te ideas for polynomials power series of a complex variable we developed in te previous capter to general

More information

Symmetry Labeling of Molecular Energies

Symmetry Labeling of Molecular Energies Capter 7. Symmetry Labeling of Molecular Energies Notes: Most of te material presented in tis capter is taken from Bunker and Jensen 1998, Cap. 6, and Bunker and Jensen 2005, Cap. 7. 7.1 Hamiltonian Symmetry

More information

Polynomials 3: Powers of x 0 + h

Polynomials 3: Powers of x 0 + h near small binomial Capter 17 Polynomials 3: Powers of + Wile it is easy to compute wit powers of a counting-numerator, it is a lot more difficult to compute wit powers of a decimal-numerator. EXAMPLE

More information

Finite Difference Methods Assignments

Finite Difference Methods Assignments Finite Difference Metods Assignments Anders Söberg and Aay Saxena, Micael Tuné, and Maria Westermarck Revised: Jarmo Rantakokko June 6, 1999 Teknisk databeandling Assignment 1: A one-dimensional eat equation

More information

Order of Accuracy. ũ h u Ch p, (1)

Order of Accuracy. ũ h u Ch p, (1) Order of Accuracy 1 Terminology We consider a numerical approximation of an exact value u. Te approximation depends on a small parameter, wic can be for instance te grid size or time step in a numerical

More information

Mass Lumping for Constant Density Acoustics

Mass Lumping for Constant Density Acoustics Lumping 1 Mass Lumping for Constant Density Acoustics William W. Symes ABSTRACT Mass lumping provides an avenue for efficient time-stepping of time-dependent problems wit conforming finite element spatial

More information

The derivative function

The derivative function Roberto s Notes on Differential Calculus Capter : Definition of derivative Section Te derivative function Wat you need to know already: f is at a point on its grap and ow to compute it. Wat te derivative

More information

Quasiperiodic phenomena in the Van der Pol - Mathieu equation

Quasiperiodic phenomena in the Van der Pol - Mathieu equation Quasiperiodic penomena in te Van der Pol - Matieu equation F. Veerman and F. Verulst Department of Matematics, Utrect University P.O. Box 80.010, 3508 TA Utrect Te Neterlands April 8, 009 Abstract Te Van

More information

2.1 THE DEFINITION OF DERIVATIVE

2.1 THE DEFINITION OF DERIVATIVE 2.1 Te Derivative Contemporary Calculus 2.1 THE DEFINITION OF DERIVATIVE 1 Te grapical idea of a slope of a tangent line is very useful, but for some uses we need a more algebraic definition of te derivative

More information

Robotic manipulation project

Robotic manipulation project Robotic manipulation project Bin Nguyen December 5, 2006 Abstract Tis is te draft report for Robotic Manipulation s class project. Te cosen project aims to understand and implement Kevin Egan s non-convex

More information

Chapter 2 Limits and Continuity

Chapter 2 Limits and Continuity 4 Section. Capter Limits and Continuity Section. Rates of Cange and Limits (pp. 6) Quick Review.. f () ( ) () 4 0. f () 4( ) 4. f () sin sin 0 4. f (). 4 4 4 6. c c c 7. 8. c d d c d d c d c 9. 8 ( )(

More information

Digital Filter Structures

Digital Filter Structures Digital Filter Structures Te convolution sum description of an LTI discrete-time system can, in principle, be used to implement te system For an IIR finite-dimensional system tis approac is not practical

More information

CS522 - Partial Di erential Equations

CS522 - Partial Di erential Equations CS5 - Partial Di erential Equations Tibor Jánosi April 5, 5 Numerical Di erentiation In principle, di erentiation is a simple operation. Indeed, given a function speci ed as a closed-form formula, its

More information

LIMITS AND DERIVATIVES CONDITIONS FOR THE EXISTENCE OF A LIMIT

LIMITS AND DERIVATIVES CONDITIONS FOR THE EXISTENCE OF A LIMIT LIMITS AND DERIVATIVES Te limit of a function is defined as te value of y tat te curve approaces, as x approaces a particular value. Te limit of f (x) as x approaces a is written as f (x) approaces, as

More information

7.1 Using Antiderivatives to find Area

7.1 Using Antiderivatives to find Area 7.1 Using Antiderivatives to find Area Introduction finding te area under te grap of a nonnegative, continuous function f In tis section a formula is obtained for finding te area of te region bounded between

More information

Math 31A Discussion Notes Week 4 October 20 and October 22, 2015

Math 31A Discussion Notes Week 4 October 20 and October 22, 2015 Mat 3A Discussion Notes Week 4 October 20 and October 22, 205 To prepare for te first midterm, we ll spend tis week working eamples resembling te various problems you ve seen so far tis term. In tese notes

More information

Chapters 19 & 20 Heat and the First Law of Thermodynamics

Chapters 19 & 20 Heat and the First Law of Thermodynamics Capters 19 & 20 Heat and te First Law of Termodynamics Te Zerot Law of Termodynamics Te First Law of Termodynamics Termal Processes Te Second Law of Termodynamics Heat Engines and te Carnot Cycle Refrigerators,

More information

(a) At what number x = a does f have a removable discontinuity? What value f(a) should be assigned to f at x = a in order to make f continuous at a?

(a) At what number x = a does f have a removable discontinuity? What value f(a) should be assigned to f at x = a in order to make f continuous at a? Solutions to Test 1 Fall 016 1pt 1. Te grap of a function f(x) is sown at rigt below. Part I. State te value of eac limit. If a limit is infinite, state weter it is or. If a limit does not exist (but is

More information

= 0 and states ''hence there is a stationary point'' All aspects of the proof dx must be correct (c)

= 0 and states ''hence there is a stationary point'' All aspects of the proof dx must be correct (c) Paper 1: Pure Matematics 1 Mark Sceme 1(a) (i) (ii) d d y 3 1x 4x x M1 A1 d y dx 1.1b 1.1b 36x 48x A1ft 1.1b Substitutes x = into teir dx (3) 3 1 4 Sows d y 0 and states ''ence tere is a stationary point''

More information

The Krewe of Caesar Problem. David Gurney. Southeastern Louisiana University. SLU 10541, 500 Western Avenue. Hammond, LA

The Krewe of Caesar Problem. David Gurney. Southeastern Louisiana University. SLU 10541, 500 Western Avenue. Hammond, LA Te Krewe of Caesar Problem David Gurney Souteastern Louisiana University SLU 10541, 500 Western Avenue Hammond, LA 7040 June 19, 00 Krewe of Caesar 1 ABSTRACT Tis paper provides an alternative to te usual

More information

Quantization of electrical conductance

Quantization of electrical conductance 1 Introduction Quantization of electrical conductance Te resistance of a wire in te classical Drude model of metal conduction is given by RR = ρρρρ AA, were ρρ, AA and ll are te conductivity of te material,

More information

Introduction to Derivatives

Introduction to Derivatives Introduction to Derivatives 5-Minute Review: Instantaneous Rates and Tangent Slope Recall te analogy tat we developed earlier First we saw tat te secant slope of te line troug te two points (a, f (a))

More information

Dynamics and Relativity

Dynamics and Relativity Dynamics and Relativity Stepen Siklos Lent term 2011 Hand-outs and examples seets, wic I will give out in lectures, are available from my web site www.damtp.cam.ac.uk/user/stcs/dynamics.tml Lecture notes,

More information

Test 2 Review. 1. Find the determinant of the matrix below using (a) cofactor expansion and (b) row reduction. A = 3 2 =

Test 2 Review. 1. Find the determinant of the matrix below using (a) cofactor expansion and (b) row reduction. A = 3 2 = Test Review Find te determinant of te matrix below using (a cofactor expansion and (b row reduction Answer: (a det + = (b Observe R R R R R R R R R Ten det B = (((det Hence det Use Cramer s rule to solve:

More information

Chapter 1D - Rational Expressions

Chapter 1D - Rational Expressions - Capter 1D Capter 1D - Rational Expressions Definition of a Rational Expression A rational expression is te quotient of two polynomials. (Recall: A function px is a polynomial in x of degree n, if tere

More information

Continuity and Differentiability Worksheet

Continuity and Differentiability Worksheet Continuity and Differentiability Workseet (Be sure tat you can also do te grapical eercises from te tet- Tese were not included below! Typical problems are like problems -3, p. 6; -3, p. 7; 33-34, p. 7;

More information

Chapter 2. Limits and Continuity 16( ) 16( 9) = = 001. Section 2.1 Rates of Change and Limits (pp ) Quick Review 2.1

Chapter 2. Limits and Continuity 16( ) 16( 9) = = 001. Section 2.1 Rates of Change and Limits (pp ) Quick Review 2.1 Capter Limits and Continuity Section. Rates of Cange and Limits (pp. 969) Quick Review..... f ( ) ( ) ( ) 0 ( ) f ( ) f ( ) sin π sin π 0 f ( ). < < < 6. < c c < < c 7. < < < < < 8. 9. 0. c < d d < c

More information

THE IDEA OF DIFFERENTIABILITY FOR FUNCTIONS OF SEVERAL VARIABLES Math 225

THE IDEA OF DIFFERENTIABILITY FOR FUNCTIONS OF SEVERAL VARIABLES Math 225 THE IDEA OF DIFFERENTIABILITY FOR FUNCTIONS OF SEVERAL VARIABLES Mat 225 As we ave seen, te definition of derivative for a Mat 111 function g : R R and for acurveγ : R E n are te same, except for interpretation:

More information

Nonlinear correction to the bending stiffness of a damaged composite beam

Nonlinear correction to the bending stiffness of a damaged composite beam Van Paepegem, W., Decaene, R. and Degrieck, J. (5). Nonlinear correction to te bending stiffness of a damaged composite beam. Nonlinear correction to te bending stiffness of a damaged composite beam W.

More information

6. Non-uniform bending

6. Non-uniform bending . Non-uniform bending Introduction Definition A non-uniform bending is te case were te cross-section is not only bent but also seared. It is known from te statics tat in suc a case, te bending moment in

More information

Parameter Fitted Scheme for Singularly Perturbed Delay Differential Equations

Parameter Fitted Scheme for Singularly Perturbed Delay Differential Equations International Journal of Applied Science and Engineering 2013. 11, 4: 361-373 Parameter Fitted Sceme for Singularly Perturbed Delay Differential Equations Awoke Andargiea* and Y. N. Reddyb a b Department

More information

Derivatives of Exponentials

Derivatives of Exponentials mat 0 more on derivatives: day 0 Derivatives of Eponentials Recall tat DEFINITION... An eponential function as te form f () =a, were te base is a real number a > 0. Te domain of an eponential function

More information

Math 212-Lecture 9. For a single-variable function z = f(x), the derivative is f (x) = lim h 0

Math 212-Lecture 9. For a single-variable function z = f(x), the derivative is f (x) = lim h 0 3.4: Partial Derivatives Definition Mat 22-Lecture 9 For a single-variable function z = f(x), te derivative is f (x) = lim 0 f(x+) f(x). For a function z = f(x, y) of two variables, to define te derivatives,

More information

Dedicated to the 70th birthday of Professor Lin Qun

Dedicated to the 70th birthday of Professor Lin Qun Journal of Computational Matematics, Vol.4, No.3, 6, 4 44. ACCELERATION METHODS OF NONLINEAR ITERATION FOR NONLINEAR PARABOLIC EQUATIONS Guang-wei Yuan Xu-deng Hang Laboratory of Computational Pysics,

More information

REVIEW LAB ANSWER KEY

REVIEW LAB ANSWER KEY REVIEW LAB ANSWER KEY. Witout using SN, find te derivative of eac of te following (you do not need to simplify your answers): a. f x 3x 3 5x x 6 f x 3 3x 5 x 0 b. g x 4 x x x notice te trick ere! x x g

More information

Research Article New Results on Multiple Solutions for Nth-Order Fuzzy Differential Equations under Generalized Differentiability

Research Article New Results on Multiple Solutions for Nth-Order Fuzzy Differential Equations under Generalized Differentiability Hindawi Publising Corporation Boundary Value Problems Volume 009, Article ID 395714, 13 pages doi:10.1155/009/395714 Researc Article New Results on Multiple Solutions for Nt-Order Fuzzy Differential Equations

More information

Recall from our discussion of continuity in lecture a function is continuous at a point x = a if and only if

Recall from our discussion of continuity in lecture a function is continuous at a point x = a if and only if Computational Aspects of its. Keeping te simple simple. Recall by elementary functions we mean :Polynomials (including linear and quadratic equations) Eponentials Logaritms Trig Functions Rational Functions

More information

Bob Brown Math 251 Calculus 1 Chapter 3, Section 1 Completed 1 CCBC Dundalk

Bob Brown Math 251 Calculus 1 Chapter 3, Section 1 Completed 1 CCBC Dundalk Bob Brown Mat 251 Calculus 1 Capter 3, Section 1 Completed 1 Te Tangent Line Problem Te idea of a tangent line first arises in geometry in te context of a circle. But before we jump into a discussion of

More information

New Streamfunction Approach for Magnetohydrodynamics

New Streamfunction Approach for Magnetohydrodynamics New Streamfunction Approac for Magnetoydrodynamics Kab Seo Kang Brooaven National Laboratory, Computational Science Center, Building 63, Room, Upton NY 973, USA. sang@bnl.gov Summary. We apply te finite

More information

1. Consider the trigonometric function f(t) whose graph is shown below. Write down a possible formula for f(t).

1. Consider the trigonometric function f(t) whose graph is shown below. Write down a possible formula for f(t). . Consider te trigonometric function f(t) wose grap is sown below. Write down a possible formula for f(t). Tis function appears to be an odd, periodic function tat as been sifted upwards, so we will use

More information

Chapter 1. Density Estimation

Chapter 1. Density Estimation Capter 1 Density Estimation Let X 1, X,..., X n be observations from a density f X x. Te aim is to use only tis data to obtain an estimate ˆf X x of f X x. Properties of f f X x x, Parametric metods f

More information

Poisson Equation in Sobolev Spaces

Poisson Equation in Sobolev Spaces Poisson Equation in Sobolev Spaces OcMountain Dayligt Time. 6, 011 Today we discuss te Poisson equation in Sobolev spaces. It s existence, uniqueness, and regularity. Weak Solution. u = f in, u = g on

More information

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis. Volume 34, pp. 14-19, 2008. Copyrigt 2008,. ISSN 1068-9613. ETNA A NOTE ON NUMERICALLY CONSISTENT INITIAL VALUES FOR HIGH INDEX DIFFERENTIAL-ALGEBRAIC EQUATIONS

More information