The method of lines (MOL) for the diffusion equation

Size: px
Start display at page:

Download "The method of lines (MOL) for the diffusion equation"

Transcription

1 Chapter 1 The method of lines (MOL) for the diffusion equation The method of lines refers to an approximation of one or more partial differential equations with ordinary differential equations in just one of the independent variables. The assumption is the ordinary differential equations are easier to analyze and solve than the partial differential equations. The approximation can be based on finite differences, finite elements, collocation or Fourier series like expansions. A method of lines obtained with finite differences seems easiest to apply and will be used exclusively in this text. In order to introduce the basic ideas used later for pricing options let us consider the diffusion equation a(x, t)u xx + b(x, t)u x c(x, t)u d(x, t)u t = f(x, t) (1.1) and the boundary and initial conditions u(0, t) = α(t), u(x, 0) = u 0 (x). u(l, t) = β(t) Options, bonds and their Greeks are described by equations like (1.1). Consistent with these applications we shall make the assumption that all coefficients in (1.1) are continuous in x and t and that a(x, t) > 0 for 0 < x < L and all t, d(x, t) > 0 for 0 < x < L and all t. 1 c Gunter H. Meyer

2 1.1. MOL WITH CONTINUOUS TIME CHAPTER 1. The coefficients b and c may change sign in specific problems. The two independent variables are x and t. In later applications the variable x will stand for an asset price or an interest rate. We shall call x the spatial variable. t stands for time, usually time to expiry of the option or bond. It is our choice whether to approximate this problem with ordinary differential equations in x or t. In subsequent chapters we shall always retain x as the continuous variable and discretize t. However, in the engineering literature the term MOL invariably refers to ordinary differential equations in t. This version is sometimes called the vertical method of lines []. For completeness, we shall give first a brief exposition of a method of lines approximation of (1.1) valid for all t and at discrete values of x, and then turn to the MOL in x. 1.1 The method of lines with continuous time (the vertical MOL) We define a mesh with 0 = x 0 < < x P = L x = L/M and x = i x, i = 0, 1,..., P, and approximate (1.1) along the line x = x i with the ordinary differential equation a(x i, t) u i+1(t) + u i 1 (t) 2u i (t) x 2 + b(x i, t) u i+1(t) u i 1 (t) c(x i, t)u i (t) u i 2 x (t) = f(x i, t) for i = 1,..., P 1, where u 0 (t) = α(t) and u M (t) = β(t), and where u i (0) = u 0 (x i ). It is possible to write these P 1 ordinary differential equations for the vector u(t) = (u 1 (t),...,u P 1 (t)) in matrix form u (t) = A(t) u + b(t) u(0) = u 0 (1.2) 2 c Gunter H. Meyer

3 CHAPTER MOL WITH CONTINUOUS TIME where A(t) is a tridiagonal matrix and the vector b(t) is determined by the source term f(x, t) and the boundary conditions {α(t), β(t)}. The initial condition u 0 = (u 0,1,...u 0,P 1 ) is defined by u 0i = u 0 (x i ). Taylor expansions can be used to show that (1.2) is a consistent approximation of (1.1). Moreover, it can be shown that under reasonable hypotheses on the data of problem (1.1) the analytic solution of (1.2) satisfies u(x i, t) u i (t) K x 2, i = 1,...,P 1 where u(x, t) is the analytic solution of (1.1) and K depends on the smoothness of u and the interval of integration [0, T] []. Of course, in general an analytic solution of (1.2) is not available. Then the system must be solved numerically. It is possible to define a numerical integrator for (1.2), for example a backward Euler method or the trapezoidal rule, so that the resulting algebraic equations are identical to standard finite difference approximations to (1.1). In this case nothing has been gained by introducing the method of lines. The attraction of (1.2) is due to the fact that the theory of ordinary differential equations yields insight into the analytic solution of (1.2), and that many efficient adaptive black box numerical codes exist for the approximate solution of initial value problems for linear and nonlinear ordinary differential equations. Thus, in principle, a highly accurate numerical of solution of (1.2) is obtainable. Coupled with the fact that the MOL discretization is readily extended to nonlinear problems and to other classes of equations, it is natural that this two step solution approach to time dependent problems has become commonplace and the basis of software for the numerical solution of time dependent partial differential equations []. For a discussion of the method of lines leading to initial value problems for ordinary differential equations, and some caveats against its thoughtless application we refer the reader to []. The transformation of a so-called parabolic initial/boundary value problem like (1.1) to (1.2) is not so straightforward when the domain of the equation changes with time, e.g. when the boundary conditions are given in the form u(s(t), t) = α(t), u(s(t), t) = β(t) (1.3) where x = s(t) and x = S(t) describe non-constant boundaries. The problem is exacerbated when s(t) or S(t) is not known a priori but a free boundary 3 c Gunter H. Meyer

4 1.2. MOL WITH CONTINUOUS x CHAPTER 1. like an early exercise boundary in an American option. It is possible to define an analog to (1.2) where {u i (t)} is an approximate solution along curves {x i (t)} (see the method of arbitrary lines [Xanthis]). Alternatively, one can map the irregular domain into a rectangle at the expense of complicating the differential equation (1.1). For this approach in a financial setting see [Tavella, Wu] where the resulting equations are solved with finite differences. We have no experience with the time-continuous MOL for financial applications and can give no insight into how well it solves, for example, American option problems. In this book, our goal is to work as much as possible with the original equation in the natural variables of the application. We believe that we can reach this goal readily by discretizing t instead of x. 1.2 The method of lines with continuous x (the horizontal MOL) For options with discontinuous pay-off, barriers, early exercise features or jumps, the solution of the Black Scholes equation can vary strongly with x at any given time. In this setting it is useful to base the method of lines on discretizing time and solving the resulting ordinary differential equation in x to a high degree of accuracy. This approach will be followed consistently throughout the remainder of this book. Assuming that problem (1.1) is to be solved over the time interval [0, T], where T is arbitrary but fixed (usually the time to expiry of the option), we introduce a partition in time where 0 = t 0 < t 1 < < t N = T t n = t n t n 1 is usually, but not necessarily, constant with respect to n. For a method of lines approximation of (1.1) at t = t n we simply replace u t by a time implicit (i.e. backward) difference quotient. Two approximations are used repeatedly. If u n (x) denotes the approximation of the solution u(x, t n ) then we employ either the backward Euler approximation u t (x, t n ) = Du n (x) = u n(x) u n 1 (x) t n (1.4) 4 c Gunter H. Meyer

5 CHAPTER MOL WITH CONTINUOUS x or the three-level difference quotient u t (x, t n ) = Du n (x) = c n u n (x) u n 1 (x) t n + d n u n 1 (x) u n 2 (x) t n 1. (1.5) A Taylor series expansion of the right hand side of (1.5) shows that the weights {c n, d n } should be chosen such that ( ) ( ) ( ) 1 1 cn 1 t n 1 t n 2 t n 1 t n + t 2 =. n 1 d n 0 In most applications the time step is constant (i.e. t n = t n 1 ). For this case the weights are c n = 3 2, d n = 1 2. In general it follows from Taylor expansions applied to (1.4) that for any smooth function φ(x, t) φ t (x, t n ) Dφ(x, t n ) = K 1 t n so that the approximation of φ t is of order t, or of first order. Similarly it follows from (1.5) that φ t (x, t) Dφ(x, t n ) = K 2 max{ t 2 n, t2 n 1 } so that the approximation of φ t is of order t 2, i.e. of second order. Here K 1 and K 2 are constants which depend only on the smoothness of φ. The method of lines approximation of (1.1) at time t = t n is given by the two point boundary value problem a(x, t n )u n(x)+b(x, t n )u n(x) c(x, t n )u n (x) d(x, t n )Du n (x) = f(x, t n ) (1.6) subject to u n (0) = α(t n ), u n (L) = β(t n ). u 0 (x) = g(x) is the given initial condition. It is well known that standard finite difference methods based on a backward Euler or an implicit three-level time discretization are unconditionally stable. As the spatial mesh parameter in the finite difference approximation decreases to zero the equation (1.6) results. Hence we may infer that both (1.4) and (1.5) yield a stable numerical method for the solution of the diffusion equation (1.1). A direct proof of 5 c Gunter H. Meyer

6 1.2. MOL WITH CONTINUOUS x CHAPTER 1. stability is provided in Appendix 1.1. We note that at the first time level t = t 1 the expression is only defined for the backward Euler quotient (1.4). Once u 1 (x) is found then for n 2 the equation (1.6) is defined for either difference quotient Du n (x). If equation (1.1) is to be solved subject to boundary data like (1.3) then the boundary conditions for (1.6) simply become u n (s(t n )) = α(t n ), u n (S(t n )) = β(t n ). However, if the interval [s(t n 1 ), S(t n 1 )] does not contain the interval [s(t n ), S(t n )] then u n 1 (x) must be extended beyond its boundary points in order to be able to define Du n (x) on [s(t n ), S(t n )]. For example, if S(t n ) > S(t n 1 ) then we would use the (smooth pasting) linear extension u n 1 (x) = u n 1 (S(t n 1 ) + u n 1 (S(t n 1)(x S(t n 1 )), x > S(t n 1 ). Analogous extensions apply to u n 2 (x) and at the lower boundary s(t). The accuracy of the approximation of u t generally implies the same accuracy for the solution of (1.1), meaning that for an analytic solution of (1.6) we can assert that u(x, t n ) u n (x) K max t 1 k or 2 k where K depends solely on the smoothness of the analytic solution u(x, t) of (1.1). A second order method is preferable, and in fact essential for an efficient MOL code for problems in finance. It comes basically for free because numerical methods for (1.6) differ little whether (1.4) or (1.5) is used. Numerical experiments verify that the performance of the method of lines is greatly improved by switching over to a second order method for n 3. In applications we shall routinely approximate u t (x, t) with the backward quotient (1.4) for n = 1 and n = 2, and then change over to the three level quotient (1.5) for n 3. The reader familiar with the Crank-Nicolson method for the diffusion equation will be aware that one could equally well define an MOL approximation involving the spatial differential operator at times t n 1 and t n. However, the Crank-Nicolson approximation requires care when initial data are non-smooth (typical for options) or the boundary and initial data are discontinuous (typical for barrier options). In fact, even though self-starting in principle, it often has to be combined with a few implicit Euler steps (sometimes referred to as Rannacher s method) to suppress unwarranted initial 6 c Gunter H. Meyer

7 CHAPTER MOL FOR MULTI-DIMENSIONAL PROBLEMS oscillations. Hence the self-starting feature is lost. The three level scheme appears simpler to apply and to give comparable results. For this reason a Crank-Nicolson based MOL will not be considered here. 1.3 The method of lines with continuous x for multi-dimensional problems Asian and basket options, stochastic volatility models and multi-factor interest rate bond options lead to multi-dimensional diffusion equations. For such equations the simplicity of the MOL described in Section 1.2 is retained, in principle, if we combine the MOL with an analog of standard line iterative methods known for algebraic approximations of multi-dimensional diffusion equations. In practice, such approach is limited to very low-dimensional problems, and we shall treat applications which involve only two spatial variables x and y. We shall consider problems of the form a 11 (x, y, t)u xx + a 12 (x, y, t)u xy + a 22 (x, y, t)u yy (1.7) + b 1 (x, y, t)u x + b 2 (x, y, t)u y c(x, y, t)u d(x, y, t)u t = f(x, y, t) on a domain D(t) = {(x, y) : s(y, t) < x < S(y, t), y 0 < y < Y }, t 0 where y 0 and Y are given numbers and s and S are smooth curves in y and t. The boundary of D(t) will be denoted by D(t). A schematic of D(t) is given in Fig.?? In applications we impose boundary conditions on u(x, y, t) on all or part of the boundary D(t), and an initial condition on u(x, y, 0). For definiteness we shall use so-called Dirichlet boundary data u(x, y, t) = α(x, y, t), (x, y) D(t) and the initial condition where α and u 0 are given functions. u(x, y, 0) = u 0 (x, y) 7 c Gunter H. Meyer

8 1.3. MOL FOR MULTI-DIMENSIONAL PROBLEMS CHAPTER 1. As in the preceding section we begin by discretizing time in (1.7). Let u n (x, y) denote an approximation to u(x, y, t n ) at time t n. We employ the difference quotients introduced in Section 1.2 u t (x, y, t n ) Du n (x, y) = { un u n for n = 1, 2 t for n = 3,...,N u n u n 1 t 1 2 u n 1 u n 2 t where t = t n t n 1 is assumed to be constant for all n. For notational convenience the argument (x, y) of u n will generally be suppressed. Moreover, if the time index n does not appear explicitly it is assumed to be the index n of the latest time step so that u(x, y) u n (x, y). The time index will be written only when it is needed for clarity. The (parabolic) initial/boundary value problem for (1.7) at time t n is approximated by the sequence of time discrete (elliptic) problems a 11 (x, y, t n )u xx + a 12 (x, y, t n )u xy + a 22 (x, y, t n )u yy + b 1 (x, y, t n )u x (1.8) + b 2 (x, y, t n )u y ĉ(x, y, t n )u = ˆf(x, y, t n ) where and ĉ(x, y, t n ) = c(x, y, t n ) + { d(x, y, t n ) 1 t for n = 1, 2 d(x, y, t n ) 3 2 t for n = 3,...,N ˆf(x, y, t n ) = f(x, y, t n ) { d(x, y, tn ) u n 1(x,y) for n = 1, 2 t ] d(x, y, t n ) for n = 3,...,N [ 3un 1 (x,y) 2 t + u n 1(x,y) u n 2 (x,y) 2 t u 0 (x, y) is given and the boundary data are evaluated at t n. In order to approximate (1.8) with ordinary differential equations in x we impose a uniform partition y 0 < y 1 < < y M = Y The points {y m } of the partition will always be indexed by m. Next we replace derivatives with respect to y in (1.8) by central difference quotients. 8 c Gunter H. Meyer

9 CHAPTER MOL FOR MULTI-DIMENSIONAL PROBLEMS If u m (x) ( u m,n (x)) denotes an approximation to u(x, y m, t n ) then with y = y m y m 1 we write u y (x, y m, t n ) = u m+1(x) u m 1 (x) 2 y u yy (x, y m, t n ) = u m+1(x) + u m 1 (x) 2u m (x) y 2 u xy (x, y m, t n ) = u m+1 (x) u m 1 (x) 2 y The method of lines approximation to (1.7) with continuous x at discrete time t n along the line y = y m for m = 1,...,M 1 takes on the form Lu(x) = a 11 (x, y m, t n )u m (x) + b 1(x, y m, t n )u m (x) c(x, y m, t n )u m (x) (1.9) = F(x, y m, t n, u m 1 (x), u m+1 (x), u m 1 (x), u m+1 (x), u m,n 1 (x), u m,n 2 (x)) where and c(x, y m, t n ) = ĉ(x, y m, t n ) + a 22 (x, y m, t n ) 2 y 2 F(x, y m, t n ) = ˆf(x, y m, t n ) a 22 (x, y m, t n ) u m+1(x) + u m 1 (x) y 2 b 2 (x, y m, t n ) u m+1(x) u m 1 (x) 2 y a 12 (x, y m, t n ) u m+1(x) u m 1(x) 2 y (We recall the notation: u m = u(x, ym, t n ), u m,n 1 (x) = u(x, y m, t n 1 ).) The initial condition yields {u m,0 (x)} M m=0 and the boundary conditions give {u m (s(y m, t n ))} and {u m (S(y m, t n ))}, u 0 (x), u M (x) and their derivatives. Equations (1.9) represent a boundary value problem for a system of M 1 coupled ordinary differential equations. If s(y, t n ) or S(y, t n ) is not constant with respect to y then the equations are defined over different x-intervals and the boundary value problem is a so-called multipoint boundary value problem. Its numerical solution is often as complicated as the numerical solution of the partial differential equation (1.8). However, for problems 9 c Gunter H. Meyer

10 1.3. MOL FOR MULTI-DIMENSIONAL PROBLEMS CHAPTER 1. arising in finance it generally is possible to solve the system (1.9) iteratively as a sequence of scalar second order equations like (1.6). We introduce a new index k for the iteration count. It appears as a superscript of u so that u k m (x) stands for the kth iterate approximating u(x, y m, t n ). At time t n let {u 0 m(x)} M 1 m=1 denote an initial guess for the solution {u m (x)} of (1.9). (Typically one would choose the solution from the preceding time step u 0 m(x) = u m,n 1 (x).) In the kth iteration for k 1 we compute a solution {u k m (x)} for m = 1,...,M 1 by solving L m u k m (x) = F(x, y m, t n, u k m 1, uk 1 m+1, u k m 1, u k 1 m+1, u m,n 1, u m,n 2 ). (1.10) Note that at any stage the right hand side F is a known source term. Assuming that the sequence {u k m (x)} converges as k we obtain u m,n (x) = lim u k m (x) for m = 1,...,M 1. k The reader familiar with iterative methods for linear algebraic systems will recognize that our iterative method is a line Gauss-Seidel iteration, except that along each line y = y m a two point boundary value problem for a second order ordinary differential equation instead of a matrix problem has to be solved. In practice we set where K is an integer such that u m,n (x) = u K m (x) max m uk m(x) u K 1 m (x) ǫ. The choice of the convergence tolerance ǫ is dictated by the accuracy required by the application and the computer time it takes for convergence. If a a 12 (x, y, t) 0 then it is possible to prove that the line Gauss Seidel method will indeed converge to a solution of the multipoint problem at each time level []. Numerical experience suggests that the iteration will also converge for problems in finance where a On occasion spurious oscillatory solutions can arise from the central difference approximation of u y (x, y, t). They can be suppressed by either decreasing y, or if that is infeasible, by replacing b 2 (x, y m, t n )u y (x, y m, t n ) 10 c Gunter H. Meyer

11 CHAPTER MOL FOR MULTI-DIMENSIONAL PROBLEMS with a lower order one-sided difference quotient. For example, if b 2 0 we would choose u y (x, y m, t n ) = u m+1 u, y if b 2 < 0 we would use u y (x, y m, t n ) = u u m 1 y These first order quotients represent an upwinding of the convection term b 2 u y in (1.7). Upwinding is a well understood and important tool in the theory of numerical methods for partial differential equations []. We also remark that if t is very large then the convergence of the line Gauss Seidel iteration may be unacceptably slow. In this case a line SOR modification of the Gauss Seidel method may prove helpful. We consider the solution of (1.10) an intermediate solution and denote it by ũ. The desired solution u k m is found from u k m = uk 1 m + ω[ũ m u k 1 m ] for some ω [1, 2]. The optimum relaxation factor ω is not known a priori but can be found by trial and error. ω = 1 yields again the Gauss Seidel iteration. Finally, we remark that it is straightforward to generalize this approach to multi-dimensional equations like. p a ij u xi x j + i,j=1 p b i u xi cu du t = f( x, t) i=1 where x = (x 1,...,x p ). Such equation would arise, for example, in connection with basket options depending on p assets. We discretize t and then x 2,...,x p and replace all derivates with respect to these variables by appropriate finite difference quotients. A system of the order of M p 1 coupled second order ordinary differential equations in the independent variable x 1 results to which a line Gauss Seidel iteration can be applied. Some parallelization of the line Gauss Seidel method is possible, but we have no practical experience with financial applications for p > 2. In summary then, the method of lines appximation for the parabolic equation describing financial derivatives is reduced at each time level to a 11 c Gunter H. Meyer

12 1.3. MOL FOR MULTI-DIMENSIONAL PROBLEMS CHAPTER 1. single linear second order differential equation (1.6), or to a sequence of such equations. This is a sensible approach only if such second order equation can be solved accurately and efficiently. As stated in Section 1.1, a standard approach would be to replace the derivatives in (1.6) by their finite difference analogs and to set up a matrix system. The resulting algorithm is again a standard finite difference algorithm for the diffusion equation found in every textbook on numerical methods for partial differential equations. Such method would not merit the detour via the method of lines approximation. Here we shall employ a less familiar algorithm for the solution of (1.6), but one which is readily adapted to the class of problems associated with American options. This algorithm is the subject of the next chapter. 12 c Gunter H. Meyer

The Riccati transformation method for linear two point boundary problems

The Riccati transformation method for linear two point boundary problems Chapter The Riccati transformation method for linear two point boundary problems The solution algorithm for two point boundary value problems to be employed here has been derived from different points

More information

Multi-Factor Finite Differences

Multi-Factor Finite Differences February 17, 2017 Aims and outline Finite differences for more than one direction The θ-method, explicit, implicit, Crank-Nicolson Iterative solution of discretised equations Alternating directions implicit

More information

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs Chapter Two: Numerical Methods for Elliptic PDEs Finite Difference Methods for Elliptic PDEs.. Finite difference scheme. We consider a simple example u := subject to Dirichlet boundary conditions ( ) u

More information

Numerical Methods for PDEs

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

More information

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Introduction Deng Li Discretization Methods Chunfang Chen, Danny Thorne, Adam Zornes CS521 Feb.,7, 2006 What do You Stand For? A PDE is a Partial Differential Equation This

More information

Finite Difference and Finite Element Methods

Finite Difference and Finite Element Methods Finite Difference and Finite Element Methods Georgy Gimel farb COMPSCI 369 Computational Science 1 / 39 1 Finite Differences Difference Equations 3 Finite Difference Methods: Euler FDMs 4 Finite Element

More information

Time-dependent variational forms

Time-dependent variational forms Time-dependent variational forms Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Oct 30, 2015 PRELIMINARY VERSION

More information

Series Solutions. 8.1 Taylor Polynomials

Series Solutions. 8.1 Taylor Polynomials 8 Series Solutions 8.1 Taylor Polynomials Polynomial functions, as we have seen, are well behaved. They are continuous everywhere, and have continuous derivatives of all orders everywhere. It also turns

More information

Lecture Notes on Numerical Schemes for Flow and Transport Problems

Lecture Notes on Numerical Schemes for Flow and Transport Problems Lecture Notes on Numerical Schemes for Flow and Transport Problems by Sri Redeki Pudaprasetya sr pudap@math.itb.ac.id Department of Mathematics Faculty of Mathematics and Natural Sciences Bandung Institute

More information

Lecture Notes on Numerical Schemes for Flow and Transport Problems

Lecture Notes on Numerical Schemes for Flow and Transport Problems Lecture Notes on Numerical Schemes for Flow and Transport Problems by Sri Redeki Pudaprasetya sr pudap@math.itb.ac.id Department of Mathematics Faculty of Mathematics and Natural Sciences Bandung Institute

More information

Finite difference methods for the diffusion equation

Finite difference methods for the diffusion equation Finite difference methods for the diffusion equation D150, Tillämpade numeriska metoder II Olof Runborg May 0, 003 These notes summarize a part of the material in Chapter 13 of Iserles. They are based

More information

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of,

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of, 269 C, Vese Practice problems [1] Write the differential equation u + u = f(x, y), (x, y) Ω u = 1 (x, y) Ω 1 n + u = x (x, y) Ω 2, Ω = {(x, y) x 2 + y 2 < 1}, Ω 1 = {(x, y) x 2 + y 2 = 1, x 0}, Ω 2 = {(x,

More information

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF MATHEMATICS ACADEMIC YEAR / EVEN SEMESTER QUESTION BANK

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF MATHEMATICS ACADEMIC YEAR / EVEN SEMESTER QUESTION BANK KINGS COLLEGE OF ENGINEERING MA5-NUMERICAL METHODS DEPARTMENT OF MATHEMATICS ACADEMIC YEAR 00-0 / EVEN SEMESTER QUESTION BANK SUBJECT NAME: NUMERICAL METHODS YEAR/SEM: II / IV UNIT - I SOLUTION OF EQUATIONS

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University The Implicit Schemes for the Model Problem The Crank-Nicolson scheme and θ-scheme

More information

Introduction to numerical schemes

Introduction to numerical schemes 236861 Numerical Geometry of Images Tutorial 2 Introduction to numerical schemes Heat equation The simple parabolic PDE with the initial values u t = K 2 u 2 x u(0, x) = u 0 (x) and some boundary conditions

More information

Time stepping methods

Time stepping methods Time stepping methods ATHENS course: Introduction into Finite Elements Delft Institute of Applied Mathematics, TU Delft Matthias Möller (m.moller@tudelft.nl) 19 November 2014 M. Möller (DIAM@TUDelft) Time

More information

Week 4: Differentiation for Functions of Several Variables

Week 4: Differentiation for Functions of Several Variables Week 4: Differentiation for Functions of Several Variables Introduction A functions of several variables f : U R n R is a rule that assigns a real number to each point in U, a subset of R n, For the next

More information

Numerical Analysis of Differential Equations Numerical Solution of Parabolic Equations

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

More information

An Introduction to Numerical Methods for Differential Equations. Janet Peterson

An Introduction to Numerical Methods for Differential Equations. Janet Peterson An Introduction to Numerical Methods for Differential Equations Janet Peterson Fall 2015 2 Chapter 1 Introduction Differential equations arise in many disciplines such as engineering, mathematics, sciences

More information

Chapter 3 Second Order Linear Equations

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

More information

MA22S3 Summary Sheet: Ordinary Differential Equations

MA22S3 Summary Sheet: Ordinary Differential Equations MA22S3 Summary Sheet: Ordinary Differential Equations December 14, 2017 Kreyszig s textbook is a suitable guide for this part of the module. Contents 1 Terminology 1 2 First order separable 2 2.1 Separable

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

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Numerical Methods for Partial Differential Equations Finite Difference Methods

More information

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

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

More information

Lecture 1. Finite difference and finite element methods. Partial differential equations (PDEs) Solving the heat equation numerically

Lecture 1. Finite difference and finite element methods. Partial differential equations (PDEs) Solving the heat equation numerically Finite difference and finite element methods Lecture 1 Scope of the course Analysis and implementation of numerical methods for pricing options. Models: Black-Scholes, stochastic volatility, exponential

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

Kasetsart University Workshop. Multigrid methods: An introduction

Kasetsart University Workshop. Multigrid methods: An introduction Kasetsart University Workshop Multigrid methods: An introduction Dr. Anand Pardhanani Mathematics Department Earlham College Richmond, Indiana USA pardhan@earlham.edu A copy of these slides is available

More information

Chapter 10. Numerical Methods

Chapter 10. Numerical Methods Chapter 0 Numerical Methods As you know, most differential equations are far too complicated to be solved by an explicit analytic formula Thus, the development of accurate numerical approximation schemes

More information

Lecture No 1 Introduction to Diffusion equations The heat equat

Lecture No 1 Introduction to Diffusion equations The heat equat Lecture No 1 Introduction to Diffusion equations The heat equation Columbia University IAS summer program June, 2009 Outline of the lectures We will discuss some basic models of diffusion equations and

More information

Computation Fluid Dynamics

Computation Fluid Dynamics Computation Fluid Dynamics CFD I Jitesh Gajjar Maths Dept Manchester University Computation Fluid Dynamics p.1/189 Garbage In, Garbage Out We will begin with a discussion of errors. Useful to understand

More information

Tutorial 2. Introduction to numerical schemes

Tutorial 2. Introduction to numerical schemes 236861 Numerical Geometry of Images Tutorial 2 Introduction to numerical schemes c 2012 Classifying PDEs Looking at the PDE Au xx + 2Bu xy + Cu yy + Du x + Eu y + Fu +.. = 0, and its discriminant, B 2

More information

13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs)

13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs) 13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs) A prototypical problem we will discuss in detail is the 1D diffusion equation u t = Du xx < x < l, t > finite-length rod u(x,

More information

2tdt 1 y = t2 + C y = which implies C = 1 and the solution is y = 1

2tdt 1 y = t2 + C y = which implies C = 1 and the solution is y = 1 Lectures - Week 11 General First Order ODEs & Numerical Methods for IVPs In general, nonlinear problems are much more difficult to solve than linear ones. Unfortunately many phenomena exhibit nonlinear

More information

LECTURE NOTES ELEMENTARY NUMERICAL METHODS. Eusebius Doedel

LECTURE NOTES ELEMENTARY NUMERICAL METHODS. Eusebius Doedel LECTURE NOTES on ELEMENTARY NUMERICAL METHODS Eusebius Doedel TABLE OF CONTENTS Vector and Matrix Norms 1 Banach Lemma 20 The Numerical Solution of Linear Systems 25 Gauss Elimination 25 Operation Count

More information

Solving the Generalized Poisson Equation Using the Finite-Difference Method (FDM)

Solving the Generalized Poisson Equation Using the Finite-Difference Method (FDM) Solving the Generalized Poisson Equation Using the Finite-Difference Method (FDM) James R. Nagel September 30, 2009 1 Introduction Numerical simulation is an extremely valuable tool for those who wish

More information

ECE539 - Advanced Theory of Semiconductors and Semiconductor Devices. Numerical Methods and Simulation / Umberto Ravaioli

ECE539 - Advanced Theory of Semiconductors and Semiconductor Devices. Numerical Methods and Simulation / Umberto Ravaioli ECE539 - Advanced Theory of Semiconductors and Semiconductor Devices 1 General concepts Numerical Methods and Simulation / Umberto Ravaioli Introduction to the Numerical Solution of Partial Differential

More information

Chapter 5. Numerical Methods: Finite Differences

Chapter 5. Numerical Methods: Finite Differences Chapter 5 Numerical Methods: Finite Differences As you know, the differential equations that can be solved by an explicit analytic formula are few and far between. Consequently, the development of accurate

More information

An Efficient Algorithm Based on Quadratic Spline Collocation and Finite Difference Methods for Parabolic Partial Differential Equations.

An Efficient Algorithm Based on Quadratic Spline Collocation and Finite Difference Methods for Parabolic Partial Differential Equations. An Efficient Algorithm Based on Quadratic Spline Collocation and Finite Difference Methods for Parabolic Partial Differential Equations by Tong Chen A thesis submitted in conformity with the requirements

More information

1. Nonlinear Equations. This lecture note excerpted parts from Michael Heath and Max Gunzburger. f(x) = 0

1. Nonlinear Equations. This lecture note excerpted parts from Michael Heath and Max Gunzburger. f(x) = 0 Numerical Analysis 1 1. Nonlinear Equations This lecture note excerpted parts from Michael Heath and Max Gunzburger. Given function f, we seek value x for which where f : D R n R n is nonlinear. f(x) =

More information

Math 4263 Homework Set 1

Math 4263 Homework Set 1 Homework Set 1 1. Solve the following PDE/BVP 2. Solve the following PDE/BVP 2u t + 3u x = 0 u (x, 0) = sin (x) u x + e x u y = 0 u (0, y) = y 2 3. (a) Find the curves γ : t (x (t), y (t)) such that that

More information

x n+1 = x n f(x n) f (x n ), n 0.

x n+1 = x n f(x n) f (x n ), n 0. 1. Nonlinear Equations Given scalar equation, f(x) = 0, (a) Describe I) Newtons Method, II) Secant Method for approximating the solution. (b) State sufficient conditions for Newton and Secant to converge.

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

Appendix C: Recapitulation of Numerical schemes

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

More information

AIMS Exercise Set # 1

AIMS Exercise Set # 1 AIMS Exercise Set #. Determine the form of the single precision floating point arithmetic used in the computers at AIMS. What is the largest number that can be accurately represented? What is the smallest

More information

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

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

More information

INTRODUCTION TO PDEs

INTRODUCTION TO PDEs INTRODUCTION TO PDEs In this course we are interested in the numerical approximation of PDEs using finite difference methods (FDM). We will use some simple prototype boundary value problems (BVP) and initial

More information

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

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

More information

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

Introduction. J.M. Burgers Center Graduate Course CFD I January Least-Squares Spectral Element Methods

Introduction. J.M. Burgers Center Graduate Course CFD I January Least-Squares Spectral Element Methods Introduction In this workshop we will introduce you to the least-squares spectral element method. As you can see from the lecture notes, this method is a combination of the weak formulation derived from

More information

MATH 353 LECTURE NOTES: WEEK 1 FIRST ORDER ODES

MATH 353 LECTURE NOTES: WEEK 1 FIRST ORDER ODES MATH 353 LECTURE NOTES: WEEK 1 FIRST ORDER ODES J. WONG (FALL 2017) What did we cover this week? Basic definitions: DEs, linear operators, homogeneous (linear) ODEs. Solution techniques for some classes

More information

Final Exam May 4, 2016

Final Exam May 4, 2016 1 Math 425 / AMCS 525 Dr. DeTurck Final Exam May 4, 2016 You may use your book and notes on this exam. Show your work in the exam book. Work only the problems that correspond to the section that you prepared.

More information

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

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

More information

COURSE Iterative methods for solving linear systems

COURSE Iterative methods for solving linear systems COURSE 0 4.3. Iterative methods for solving linear systems Because of round-off errors, direct methods become less efficient than iterative methods for large systems (>00 000 variables). An iterative scheme

More information

Numerical Analysis of Differential Equations Numerical Solution of Elliptic Boundary Value

Numerical Analysis of Differential Equations Numerical Solution of Elliptic Boundary Value Numerical Analysis of Differential Equations 188 5 Numerical Solution of Elliptic Boundary Value Problems 5 Numerical Solution of Elliptic Boundary Value Problems TU Bergakademie Freiberg, SS 2012 Numerical

More information

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

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

More information

Basic Aspects of Discretization

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

More information

Existence Theory: Green s Functions

Existence Theory: Green s Functions Chapter 5 Existence Theory: Green s Functions In this chapter we describe a method for constructing a Green s Function The method outlined is formal (not rigorous) When we find a solution to a PDE by constructing

More information

Partial Differential Equations with Numerical Methods

Partial Differential Equations with Numerical Methods Stig Larsson Vidar Thomée Partial Differential Equations with Numerical Methods May 2, 2003 Springer Berlin Heidelberg New York Barcelona Hong Kong London Milan Paris Tokyo Preface Our purpose in this

More information

8.6 Partial Fraction Decomposition

8.6 Partial Fraction Decomposition 628 Systems of Equations and Matrices 8.6 Partial Fraction Decomposition This section uses systems of linear equations to rewrite rational functions in a form more palatable to Calculus students. In College

More information

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS JASON ALBRIGHT, YEKATERINA EPSHTEYN, AND QING XIA Abstract. Highly-accurate numerical methods that can efficiently

More information

Finite Difference Methods for Boundary Value Problems

Finite Difference Methods for Boundary Value Problems Finite Difference Methods for Boundary Value Problems October 2, 2013 () Finite Differences October 2, 2013 1 / 52 Goals Learn steps to approximate BVPs using the Finite Difference Method Start with two-point

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 11 Partial Differential Equations Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002.

More information

NUMERICAL METHODS FOR ENGINEERING APPLICATION

NUMERICAL METHODS FOR ENGINEERING APPLICATION NUMERICAL METHODS FOR ENGINEERING APPLICATION Second Edition JOEL H. FERZIGER A Wiley-Interscience Publication JOHN WILEY & SONS, INC. New York / Chichester / Weinheim / Brisbane / Singapore / Toronto

More information

1 Review of di erential calculus

1 Review of di erential calculus Review of di erential calculus This chapter presents the main elements of di erential calculus needed in probability theory. Often, students taking a course on probability theory have problems with concepts

More information

Week 6 Notes, Math 865, Tanveer

Week 6 Notes, Math 865, Tanveer Week 6 Notes, Math 865, Tanveer. Energy Methods for Euler and Navier-Stokes Equation We will consider this week basic energy estimates. These are estimates on the L 2 spatial norms of the solution u(x,

More information

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

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

More information

and the compositional inverse when it exists is A.

and the compositional inverse when it exists is A. Lecture B jacques@ucsd.edu Notation: R denotes a ring, N denotes the set of sequences of natural numbers with finite support, is a generic element of N, is the infinite zero sequence, n 0 R[[ X]] denotes

More information

Introduction to Partial Differential Equations

Introduction to Partial Differential Equations Introduction to Partial Differential Equations Partial differential equations arise in a number of physical problems, such as fluid flow, heat transfer, solid mechanics and biological processes. These

More information

Lecture 4: Numerical solution of ordinary differential equations

Lecture 4: Numerical solution of ordinary differential equations Lecture 4: Numerical solution of ordinary differential equations Department of Mathematics, ETH Zürich General explicit one-step method: Consistency; Stability; Convergence. High-order methods: Taylor

More information

JUST THE MATHS UNIT NUMBER 1.5. ALGEBRA 5 (Manipulation of algebraic expressions) A.J.Hobson

JUST THE MATHS UNIT NUMBER 1.5. ALGEBRA 5 (Manipulation of algebraic expressions) A.J.Hobson JUST THE MATHS UNIT NUMBER 1.5 ALGEBRA 5 (Manipulation of algebraic expressions) by A.J.Hobson 1.5.1 Simplification of expressions 1.5.2 Factorisation 1.5.3 Completing the square in a quadratic expression

More information

Partial differential equations

Partial differential equations Partial differential equations Many problems in science involve the evolution of quantities not only in time but also in space (this is the most common situation)! We will call partial differential equation

More information

In this chapter we study elliptical PDEs. That is, PDEs of the form. 2 u = lots,

In this chapter we study elliptical PDEs. That is, PDEs of the form. 2 u = lots, Chapter 8 Elliptic PDEs In this chapter we study elliptical PDEs. That is, PDEs of the form 2 u = lots, where lots means lower-order terms (u x, u y,..., u, f). Here are some ways to think about the physical

More information

Part 1. The diffusion equation

Part 1. The diffusion equation Differential Equations FMNN10 Graded Project #3 c G Söderlind 2016 2017 Published 2017-11-27. Instruction in computer lab 2017-11-30/2017-12-06/07. Project due date: Monday 2017-12-11 at 12:00:00. Goals.

More information

High Performance Nonlinear Solvers

High Performance Nonlinear Solvers What is a nonlinear system? High Performance Nonlinear Solvers Michael McCourt Division Argonne National Laboratory IIT Meshfree Seminar September 19, 2011 Every nonlinear system of equations can be described

More information

Chapter 4 Notes, Calculus I with Precalculus 3e Larson/Edwards

Chapter 4 Notes, Calculus I with Precalculus 3e Larson/Edwards 4.1 The Derivative Recall: For the slope of a line we need two points (x 1,y 1 ) and (x 2,y 2 ). Then the slope is given by the formula: m = y x = y 2 y 1 x 2 x 1 On a curve we can find the slope of a

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 11 Partial Differential Equations Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002.

More information

Applied Math Qualifying Exam 11 October Instructions: Work 2 out of 3 problems in each of the 3 parts for a total of 6 problems.

Applied Math Qualifying Exam 11 October Instructions: Work 2 out of 3 problems in each of the 3 parts for a total of 6 problems. Printed Name: Signature: Applied Math Qualifying Exam 11 October 2014 Instructions: Work 2 out of 3 problems in each of the 3 parts for a total of 6 problems. 2 Part 1 (1) Let Ω be an open subset of R

More information

Implicit Scheme for the Heat Equation

Implicit Scheme for the Heat Equation Implicit Scheme for the Heat Equation Implicit scheme for the one-dimensional heat equation Once again we consider the one-dimensional heat equation where we seek a u(x, t) satisfying u t = νu xx + f(x,

More information

McGill University Department of Mathematics and Statistics. Ph.D. preliminary examination, PART A. PURE AND APPLIED MATHEMATICS Paper BETA

McGill University Department of Mathematics and Statistics. Ph.D. preliminary examination, PART A. PURE AND APPLIED MATHEMATICS Paper BETA McGill University Department of Mathematics and Statistics Ph.D. preliminary examination, PART A PURE AND APPLIED MATHEMATICS Paper BETA 17 August, 2018 1:00 p.m. - 5:00 p.m. INSTRUCTIONS: (i) This paper

More information

Numerical Methods. King Saud University

Numerical Methods. King Saud University Numerical Methods King Saud University Aims In this lecture, we will... find the approximate solutions of derivative (first- and second-order) and antiderivative (definite integral only). Numerical Differentiation

More information

Lecture 3 Partial Differential Equations

Lecture 3 Partial Differential Equations Lecture 3 Partial Differential Equations Prof. Massimo Guidolin Prep Course in Investments August-September 2016 Plan of the lecture Motivation and generalities The heat equation and its applications in

More information

SCHOOL OF MATHEMATICS MATHEMATICS FOR PART I ENGINEERING. Self-paced Course

SCHOOL OF MATHEMATICS MATHEMATICS FOR PART I ENGINEERING. Self-paced Course SCHOOL OF MATHEMATICS MATHEMATICS FOR PART I ENGINEERING Self-paced Course MODULE ALGEBRA Module Topics Simplifying expressions and algebraic functions Rearranging formulae Indices 4 Rationalising a denominator

More information

CAAM 454/554: Stationary Iterative Methods

CAAM 454/554: Stationary Iterative Methods CAAM 454/554: Stationary Iterative Methods Yin Zhang (draft) CAAM, Rice University, Houston, TX 77005 2007, Revised 2010 Abstract Stationary iterative methods for solving systems of linear equations are

More information

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

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

More information

Power series solutions for 2nd order linear ODE s (not necessarily with constant coefficients) a n z n. n=0

Power series solutions for 2nd order linear ODE s (not necessarily with constant coefficients) a n z n. n=0 Lecture 22 Power series solutions for 2nd order linear ODE s (not necessarily with constant coefficients) Recall a few facts about power series: a n z n This series in z is centered at z 0. Here z can

More information

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS JASON ALBRIGHT, YEKATERINA EPSHTEYN, AND QING XIA Abstract. Highly-accurate numerical methods that can efficiently

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University A Model Problem in a 2D Box Region Let us consider a model problem of parabolic

More information

Finite difference method for elliptic problems: I

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

More information

Economics 672 Fall 2017 Tauchen. Jump Regression

Economics 672 Fall 2017 Tauchen. Jump Regression Economics 672 Fall 2017 Tauchen 1 Main Model In the jump regression setting we have Jump Regression X = ( Z Y where Z is the log of the market index and Y is the log of an asset price. The dynamics are

More information

PHYS 410/555 Computational Physics Solution of Non Linear Equations (a.k.a. Root Finding) (Reference Numerical Recipes, 9.0, 9.1, 9.

PHYS 410/555 Computational Physics Solution of Non Linear Equations (a.k.a. Root Finding) (Reference Numerical Recipes, 9.0, 9.1, 9. PHYS 410/555 Computational Physics Solution of Non Linear Equations (a.k.a. Root Finding) (Reference Numerical Recipes, 9.0, 9.1, 9.4) We will consider two cases 1. f(x) = 0 1-dimensional 2. f(x) = 0 d-dimensional

More information

Introduction to Boundary Value Problems

Introduction to Boundary Value Problems Chapter 5 Introduction to Boundary Value Problems When we studied IVPs we saw that we were given the initial value of a function and a differential equation which governed its behavior for subsequent times.

More information

3.4. Monotonicity of Advection Schemes

3.4. Monotonicity of Advection Schemes 3.4. Monotonicity of Advection Schemes 3.4.1. Concept of Monotonicity When numerical schemes are used to advect a monotonic function, e.g., a monotonically decreasing function of x, the numerical solutions

More information

Relevant self-assessment exercises: [LIST SELF-ASSESSMENT EXERCISES HERE]

Relevant self-assessment exercises: [LIST SELF-ASSESSMENT EXERCISES HERE] Chapter 6 Finite Volume Methods In the previous chapter we have discussed finite difference methods for the discretization of PDEs. In developing finite difference methods we started from the differential

More information

ME Computational Fluid Mechanics Lecture 5

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

More information

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

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

More information

Chapter 2 Boundary and Initial Data

Chapter 2 Boundary and Initial Data Chapter 2 Boundary and Initial Data Abstract This chapter introduces the notions of boundary and initial value problems. Some operator notation is developed in order to represent boundary and initial value

More information

Chapter 10: Partial Differential Equations

Chapter 10: Partial Differential Equations 1.1: Introduction Chapter 1: Partial Differential Equations Definition: A differential equations whose dependent variable varies with respect to more than one independent variable is called a partial differential

More information

Assignment on iterative solution methods and preconditioning

Assignment on iterative solution methods and preconditioning Division of Scientific Computing, Department of Information Technology, Uppsala University Numerical Linear Algebra October-November, 2018 Assignment on iterative solution methods and preconditioning 1.

More information

Sparse Linear Systems. Iterative Methods for Sparse Linear Systems. Motivation for Studying Sparse Linear Systems. Partial Differential Equations

Sparse Linear Systems. Iterative Methods for Sparse Linear Systems. Motivation for Studying Sparse Linear Systems. Partial Differential Equations Sparse Linear Systems Iterative Methods for Sparse Linear Systems Matrix Computations and Applications, Lecture C11 Fredrik Bengzon, Robert Söderlund We consider the problem of solving the linear system

More information

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

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

More information