Lecture 20 Heat Equation and Parabolic Problems

Size: px
Start display at page:

Download "Lecture 20 Heat Equation and Parabolic Problems"

Transcription

1 .539 Lecture 2 Heat Equation and Parabolic Problems Prof. Dean Wang. Classification of Differential Equations In most texts the classification is given for a linear second-order differential equation in two indepent variables of the form au + bu " + cu + du + eu + fu = g () The classification deps on the sign of the discriminant, b 4ac < elliptic = parabolic > hyperbolic Example : Poisson equation: u + u = g elliptic problem Heat equation: u = ku parabolic problem Wave equation: u = c u hyperbolic problem Transport equation: u + au = hyperbolic problem (2) 2. Numerical Methods for Heat Equations A simple D Heat equation: u = αu x u x, = η x u, t = g t u, t = g t This is the classic example of a parabolic equation, and many of the general properties seen here carry over to the design of numerical method for other parabolic equations. (3) In practice we solve (3) on a discrete grid with grid points x, t, where x = jh (4a) t = nk (4b) Here h is the mesh spacing on the x-axis and k = t is the time step. Let U u x, t represents the numerical approximation at grid point x, t. One simple numerical discretization of (3) is = αd U = U 2U + U (5) This employs a standard centered difference in space and a forward difference in time. This is an explicit method since we can compute each U explicitly in terms of the previous values:

2 U = U + " U 2U + U (6) Figure shows the stencil of this method. Fig.. An explicit scheme. Another one-step method, which is much more useful in practice, as we will see below, is the Crank-Nicolson method (see Figure 2), = " " = + (7) which can be rewritten as U = U + " U 2U + U + U 2U + U or ru + + 2r U ru = ru + 2r U + ru where r = " () Figure 2 shows the stencil for this method. This is an implicit method and gives a tridiagonal system of equations to solve for all the values U simultaneously. (8) (9) Fig. 2. An implicit method. 2

3 In matrix form this is + 2r r r + 2r r r + 2r r r + 2r r r + 2r r g t + g t + 2r U + ru ru + 2r U + ru = ru + 2r U + ru ru + 2r U + ru + 2r U + r g t + g t ru U U U U U () Since a tridiagonal system of m equations can be solved with O m work, this method is essentially as efficient per time step as an explicit method. Example 2. Solve the following heat equation. u = u x u x, = 2x x 2 2x x u, t = u, t = (2) Matlab program: %% Solve the heat equation % ut = uxx for <= x <=, u() = u() = %% Create the mesh % Create the time-step size t = ; k =.2; % Create the spatial grid x = ; x_ = ; % Initialize the grid spacing h =.5; % Total number of mesh points m = (x_-x)/h + ; x = linspace(x,x_,m); %% Solve the time integration using the explicit method % Initialize U U = zeros(m:); for i = :m if (x(i) <= /2) U(i) = 2*x(i); 3

4 U(i) = 2-2*x(i); % Initial value U() = ; U(m) = ; U_n = zeros(m:); U_n() = ; U_n(m) = ; figure subplot(3,2,); for i = :5 for j = 2:m- U_n(j) = U(j) + k/h^2*(u(j-) - 2*U(j) + U(j+)); % Swap the old and new values U = U_n; if mod(i, ) == plot(x,u); axis([ ]); title({['explicit method (time step size: pause(.); %% Solve the heat equation using the Crank-Nicolson method % Set up the linear system of m-2 equations: AU = F % Create the coefficient matrix A r = k/2/h^2; A = zeros(m-2,m-2); F = zeros(m-2,); U = zeros(m,); for i = :m if (x(i) <= /2) U(i) = 2*x(i); U(i) = 2-2*x(i); U_n = zeros(m,); A(,) = + 2*r; A(,2) = -r; A(m-2,m-2) = + 2*r; A(j,j-) = -r; A(j,j) = + 2*r; A(j,j+) = -r; subplot(3,2,2); % Time integration for i = :5 F() = ( - 2*r)*U(2) + r*u(3); F(m-2) = r*u(m-2) + ( - 2*r)*U(m-); F(j) = r*u(j) + ( - 2*r)*U(j+) + r*u(j+2); 4

5 % Solve the linear system U_n(2:m-) = A\F; U = U_n; % Visualize the results if mod(i, ) == plot(x,u); axis([ ]); title({['crank-nicolson method (time step size: pause(.); k =.5; for i = :m if (x(i) <= /2) U(i) = 2*x(i); U(i) = 2-2*x(i); subplot(3,2,3); for i = :4 for j = 2:m- U_n(j) = U(j) + k/h^2*(u(j-) - 2*U(j) + U(j+)); % Swap the old and new values U = U_n; if mod(i, ) == plot(x,u); axis([ ]); title({['explicit method (time step size: pause(.); %% Solve the heat equation using the Crank-Nicolson method % Set up the linear system of m-2 equations: AU = F % Create the coefficient matrix A r = k/2/h^2; A = zeros(m-2,m-2); F = zeros(m-2,); U = zeros(m,); for i = :m if (x(i) <= /2) U(i) = 2*x(i); U(i) = 2-2*x(i); A(,) = + 2*r; A(,2) = -r; A(m-2,m-2) = + 2*r; 5

6 A(j,j-) = -r; A(j,j) = + 2*r; A(j,j+) = -r; U_n = zeros(m,); A(,) = + 2*r; A(,2) = -r; A(m-2,m-2) = + 2*r; subplot(3,2,4); % Time integration for i = :4 F() = ( - 2*r)*U(2) + r*u(3); F(m-2) = r*u(m-2) + ( - 2*r)*U(m-); F(j) = r*u(j) + ( - 2*r)*U(j+) + r*u(j+2); % Solve the linear system U_n(2:m-) = A\F; U = U_n; % Visualize the results if mod(i, ) == plot(x,u); axis([ ]); title({['crank-nicolson method (time step size: pause(.); k =.; for i = :m if (x(i) <= /2) U(i) = 2*x(i); U(i) = 2-2*x(i); subplot(3,2,5); for i = :6 for j = 2:m- U_n(j) = U(j) + k/h^2*(u(j-) - 2*U(j) + U(j+)); % Swap the old and new values U = U_n; if mod(i, ) == plot(x,u); axis([ ]); title({['explicit method (time step size: pause(.); %% Solve the heat equation using the Crank-Nicolson method 6

7 % Set up the linear system of m-2 equations: AU = F % Create the coefficient matrix A %k =.5; r = k/2/h^2; A = zeros(m-2,m-2); F = zeros(m-2,); U = zeros(m,); for i = :m if (x(i) <= /2) U(i) = 2*x(i); U(i) = 2-2*x(i); A(,) = + 2*r; A(,2) = -r; A(m-2,m-2) = + 2*r; A(j,j-) = -r; A(j,j) = + 2*r; A(j,j+) = -r; U_n = zeros(m,); A(,) = + 2*r; A(,2) = -r; A(m-2,m-2) = + 2*r; subplot(3,2,6); % Time integration for i = :6 F() = ( - 2*r)*U(2) + r*u(3); F(m-2) = r*u(m-2) + ( - 2*r)*U(m-); F(j) = r*u(j) + ( - 2*r)*U(j+) + r*u(j+2); % Solve the linear system U_n(2:m-) = A\F; U = U_n; % Visualize the results if mod(i, ) == plot(x,u); axis([ ]); title({['crank-nicolson method (time step size: pause(.); 7

8 Explicit method (time step size:.2) time steps: 5 Crank-Nicolson method (time step size:.2) time steps: Explicit method (time step size:.5) time steps: Crank-Nicolson method (time step size:.5) time steps: Explicit method (time step size:.) time steps: Crank-Nicolson method (time step size:.) time steps: Stability Analysis of Numerical Methods From the above example, we can see that the explicit method becomes unstable when the time-step size is larger than the certain value, while the implicit Crank- Nicolson method is stable no matter what time-step size is used. We can understand why the explicit methods are more restrictive in the time-step size than the implicit methods by performing Fourier analysis. We define U = λ e " (3) So we have U = λ e " = λ e " e " = e " U (4) = λ e " = λ e " e " = e " U (5) U Substituting (3), (4), and (5) into the explicit method (6) gives λu = U + μ e " U 2U + e " U (6) where μ = " (7) Dividing (6) by U results in λ = + μ e " 2 + e " 8

9 = 2μ cos ξh = 4μsin (8) λ ξ is called the amplification factor for the mode ξ (wave number). Numerical stability requites that λ (9) So we must have μ = " (2) Then it requires that the time-step size k In Example 2, h =.5 and α =, so for numerical stability we should have (2) k." =.25 (22) So it can be seen that for k =.5 and., the solutions blowup. Now we perform stability analysis for the implicit Crank-Nicolson method. Substituting (3), (4), and (5) into the explicit method (9) gives rλe " U + + 2r λu rλe " U = re " U + 2r U + re " U (23) Dividing (23) by U gives rλe " + + 2r λ rλe " = re " + 2r + re " (24) So we have λ = "" " " "# = " " = "# "# "# (25) Therefore the Crank-Nicolson is stable no matter what time step is used. 9

32.4. Parabolic PDEs. Introduction. Prerequisites. Learning Outcomes

32.4. Parabolic PDEs. Introduction. Prerequisites. Learning Outcomes Parabolic PDEs 32.4 Introduction Second-order partial differential equations (PDEs) may be classified as parabolic, hyperbolic or elliptic. Parabolic and hyperbolic PDEs often model time dependent processes

More information

Finite Element Method

Finite Element Method In Finite Difference Methods: the solution domain is divided into a grid of discrete points or nodes the PDE is then written for each node and its derivatives replaced by finite-divided differences In

More information

(Refer Slide Time: 01:17)

(Refer Slide Time: 01:17) Computational Electromagnetics and Applications Professor Krish Sankaran Indian Institute of Technology Bombay Lecture 06/Exercise 03 Finite Difference Methods 1 The Example which we are going to look

More information

1 Explicit Euler Scheme (or Euler Forward Scheme )

1 Explicit Euler Scheme (or Euler Forward Scheme ) Numerical methods for PDE in Finance - M2MO - Paris Diderot American options January 2018 Files: https://ljll.math.upmc.fr/bokanowski/enseignement/2017/m2mo/m2mo.html We look for a numerical approximation

More information

1 Explicit Euler Scheme (or Euler Forward Scheme )

1 Explicit Euler Scheme (or Euler Forward Scheme ) Numerical methods for PDE in Finance - M2MO - Paris Diderot American options January 2017 Files: https://ljll.math.upmc.fr/bokanowski/enseignement/2016/m2mo/m2mo.html We look for a numerical approximation

More information

Chapter 5 Finite Difference Methods. Math6911 W07, HM Zhu

Chapter 5 Finite Difference Methods. Math6911 W07, HM Zhu Chapter 5 Finite Difference Methods Math69 W07, HM Zhu References. Chapters 5 and 9, Brandimarte. Section 7.8, Hull 3. Chapter 7, Numerical analysis, Burden and Faires Outline Finite difference (FD) approximation

More information

AEM Computational Fluid Dynamics Instructor: Dr. M. A. R. Sharif

AEM Computational Fluid Dynamics Instructor: Dr. M. A. R. Sharif AEM 620 - Computational Fluid Dynamics Instructor: Dr. M. A. R. Sharif Numerical Solution Techniques for 1-D Parabolic Partial Differential Equations: Transient Flow Problem by Parshant Dhand September

More information

Application of an Interval Backward Finite Difference Method for Solving the One-Dimensional Heat Conduction Problem

Application of an Interval Backward Finite Difference Method for Solving the One-Dimensional Heat Conduction Problem Application of an Interval Backward Finite Difference Method for Solving the One-Dimensional Heat Conduction Problem Malgorzata A. Jankowska 1, Andrzej Marciniak 2 and Tomasz Hoffmann 2 1 Poznan University

More information

Project 1: Double Pendulum

Project 1: Double Pendulum Final Projects Introduction to Numerical Analysis II http://www.math.ucsb.edu/ atzberg/winter2009numericalanalysis/index.html Professor: Paul J. Atzberger Due: Friday, March 20th Turn in to TA s Mailbox:

More information

Strong Stability Preserving Time Discretizations

Strong Stability Preserving Time Discretizations Strong Stability Preserving Time Discretizations Sigal Gottlieb University of Massachusetts Dartmouth AFOSR Computational Math Program Review August 2015 SSP time stepping August2015 1 / 33 Past and Current

More information

Advanced Numerical Methods for Financial Problems

Advanced Numerical Methods for Financial Problems Advanced Numerical Methods for Financial Problems Pricing of Derivatives Krasimir Milanov krasimir.milanov@finanalytica.com Department of Research and Development FinAnalytica Ltd. Seminar: Signal Analysis

More information

Implementing Models in Quantitative Finance: Methods and Cases

Implementing Models in Quantitative Finance: Methods and Cases Gianluca Fusai Andrea Roncoroni Implementing Models in Quantitative Finance: Methods and Cases vl Springer Contents Introduction xv Parti Methods 1 Static Monte Carlo 3 1.1 Motivation and Issues 3 1.1.1

More information

An improvement of the douglas scheme for the Black-Scholes equation

An improvement of the douglas scheme for the Black-Scholes equation Kuwait J. Sci. 42 (3) pp. 105-119, 2015 An improvement of the douglas scheme for the Black-Scholes equation FARES AL-AZEMI Department of Mathematics, Kuwait University, Safat, 13060, Kuwait. fares@sci.kuniv.edu.kw

More information

Riemannian Geometry, Key to Homework #1

Riemannian Geometry, Key to Homework #1 Riemannian Geometry Key to Homework # Let σu v sin u cos v sin u sin v cos u < u < π < v < π be a parametrization of the unit sphere S {x y z R 3 x + y + z } Fix an angle < θ < π and consider the parallel

More information

A local RBF method based on a finite collocation approach

A local RBF method based on a finite collocation approach Boundary Elements and Other Mesh Reduction Methods XXXVIII 73 A local RBF method based on a finite collocation approach D. Stevens & H. Power Department of Mechanical Materials and Manufacturing Engineering,

More information

AN OPERATOR SPLITTING METHOD FOR PRICING THE ELS OPTION

AN OPERATOR SPLITTING METHOD FOR PRICING THE ELS OPTION J. KSIAM Vol.14, No.3, 175 187, 21 AN OPERATOR SPLITTING METHOD FOR PRICING THE ELS OPTION DARAE JEONG, IN-SUK WEE, AND JUNSEOK KIM DEPARTMENT OF MATHEMATICS, KOREA UNIVERSITY, SEOUL 136-71, KOREA E-mail

More information

Crank Nicolson Scheme

Crank Nicolson Scheme Crank Nicolson Scheme De to some limitations over Explicit Scheme, mainly regarding convergence and stability, another schemes were developed which have less trncation error and which are nconditionally

More information

Write legibly. Unreadable answers are worthless.

Write legibly. Unreadable answers are worthless. MMF 2021 Final Exam 1 December 2016. This is a closed-book exam: no books, no notes, no calculators, no phones, no tablets, no computers (of any kind) allowed. Do NOT turn this page over until you are

More information

CS476/676 Mar 6, Today s Topics. American Option: early exercise curve. PDE overview. Discretizations. Finite difference approximations

CS476/676 Mar 6, Today s Topics. American Option: early exercise curve. PDE overview. Discretizations. Finite difference approximations CS476/676 Mar 6, 2019 1 Today s Topics American Option: early exercise curve PDE overview Discretizations Finite difference approximations CS476/676 Mar 6, 2019 2 American Option American Option: PDE Complementarity

More information

NUMERICAL METHODS OF PARTIAL INTEGRO-DIFFERENTIAL EQUATIONS FOR OPTION PRICE

NUMERICAL METHODS OF PARTIAL INTEGRO-DIFFERENTIAL EQUATIONS FOR OPTION PRICE Trends in Mathematics - New Series Information Center for Mathematical Sciences Volume 13, Number 1, 011, pages 1 5 NUMERICAL METHODS OF PARTIAL INTEGRO-DIFFERENTIAL EQUATIONS FOR OPTION PRICE YONGHOON

More information

The Use of Numerical Methods in Solving Pricing Problems for Exotic Financial Derivatives with a Stochastic Volatility

The Use of Numerical Methods in Solving Pricing Problems for Exotic Financial Derivatives with a Stochastic Volatility The Use of Numerical Methods in Solving Pricing Problems for Exotic Financial Derivatives with a Stochastic Volatility Rachael England September 6, 2006 1 Rachael England 2 Declaration I confirm that this

More information

Numerical Solution of BSM Equation Using Some Payoff Functions

Numerical Solution of BSM Equation Using Some Payoff Functions Mathematics Today Vol.33 (June & December 017) 44-51 ISSN 0976-38, E-ISSN 455-9601 Numerical Solution of BSM Equation Using Some Payoff Functions Dhruti B. Joshi 1, Prof.(Dr.) A. K. Desai 1 Lecturer in

More information

Numerical valuation for option pricing under jump-diffusion models by finite differences

Numerical valuation for option pricing under jump-diffusion models by finite differences Numerical valuation for option pricing under jump-diffusion models by finite differences YongHoon Kwon Younhee Lee Department of Mathematics Pohang University of Science and Technology June 23, 2010 Table

More information

Finite difference method for the Black and Scholes PDE (TP-1)

Finite difference method for the Black and Scholes PDE (TP-1) Numerical metods for PDE in Finance - ENSTA - S1-1/MMMEF Finite difference metod for te Black and Scoles PDE (TP-1) November 2015 1 Te Euler Forward sceme We look for a numerical approximation of te European

More information

As an example, we consider the following PDE with one variable; Finite difference method is one of numerical method for the PDE.

As an example, we consider the following PDE with one variable; Finite difference method is one of numerical method for the PDE. 7. Introduction to the numerical integration of PDE. As an example, we consider the following PDE with one variable; Finite difference method is one of numerical method for the PDE. Accuracy requirements

More information

The Du Fort and Frankel finite difference scheme applied to and adapted for a class of finance problems

The Du Fort and Frankel finite difference scheme applied to and adapted for a class of finance problems The Du Fort and Frankel finite difference scheme applied to and adapted for a class of finance problems by Abraham Bouwer Submitted in partial fulfillment of the requirements for the degree Magister Scientiae

More information

SPDE and portfolio choice (joint work with M. Musiela) Princeton University. Thaleia Zariphopoulou The University of Texas at Austin

SPDE and portfolio choice (joint work with M. Musiela) Princeton University. Thaleia Zariphopoulou The University of Texas at Austin SPDE and portfolio choice (joint work with M. Musiela) Princeton University November 2007 Thaleia Zariphopoulou The University of Texas at Austin 1 Performance measurement of investment strategies 2 Market

More information

Research Article Exponential Time Integration and Second-Order Difference Scheme for a Generalized Black-Scholes Equation

Research Article Exponential Time Integration and Second-Order Difference Scheme for a Generalized Black-Scholes Equation Applied Mathematics Volume 1, Article ID 796814, 1 pages doi:11155/1/796814 Research Article Exponential Time Integration and Second-Order Difference Scheme for a Generalized Black-Scholes Equation Zhongdi

More information

Numerical Methods in Option Pricing (Part III)

Numerical Methods in Option Pricing (Part III) Numerical Methods in Option Pricing (Part III) E. Explicit Finite Differences. Use of the Forward, Central, and Symmetric Central a. In order to obtain an explicit solution for the price of the derivative,

More information

PDE Project Course 1. Adaptive finite element methods

PDE Project Course 1. Adaptive finite element methods PDE Project Course 1. Adaptive finite element methods Anders Logg logg@math.chalmers.se Department of Computational Mathematics PDE Project Course 03/04 p. 1 Lecture plan Introduction to FEM FEM for Poisson

More information

Introduction to Numerical PDEs

Introduction to Numerical PDEs Introduction to Numerical PDEs Varun Shankar February 16, 2016 1 Introduction In this chapter, we will introduce a general classification scheme for linear second-order PDEs, and discuss when they have

More information

MATH6911: Numerical Methods in Finance. Final exam Time: 2:00pm - 5:00pm, April 11, Student Name (print): Student Signature: Student ID:

MATH6911: Numerical Methods in Finance. Final exam Time: 2:00pm - 5:00pm, April 11, Student Name (print): Student Signature: Student ID: MATH6911 Page 1 of 16 Winter 2007 MATH6911: Numerical Methods in Finance Final exam Time: 2:00pm - 5:00pm, April 11, 2007 Student Name (print): Student Signature: Student ID: Question Full Mark Mark 1

More information

PDE Methods for the Maximum Drawdown

PDE Methods for the Maximum Drawdown PDE Methods for the Maximum Drawdown Libor Pospisil, Jan Vecer Columbia University, Department of Statistics, New York, NY 127, USA April 1, 28 Abstract Maximum drawdown is a risk measure that plays an

More information

arxiv: v1 [q-fin.cp] 1 Nov 2016

arxiv: v1 [q-fin.cp] 1 Nov 2016 Essentially high-order compact schemes with application to stochastic volatility models on non-uniform grids arxiv:1611.00316v1 [q-fin.cp] 1 Nov 016 Bertram Düring Christof Heuer November, 016 Abstract

More information

Conservative and Finite Volume Methods for the Pricing Problem

Conservative and Finite Volume Methods for the Pricing Problem Conservative and Finite Volume Methods for the Pricing Problem Master Thesis M.Sc. Computer Simulation in Science Germán I. Ramírez-Espinoza Faculty of Mathematics and Natural Science Bergische Universität

More information

Lecture 4 - Finite differences methods for PDEs

Lecture 4 - Finite differences methods for PDEs Finite diff. Lecture 4 - Finite differences methods for PDEs Lina von Sydow Finite differences, Lina von Sydow, (1 : 18) Finite difference methods Finite diff. Black-Scholes equation @v @t + 1 2 2 s 2

More information

Chapter 20: An Introduction to ADI and Splitting Schemes

Chapter 20: An Introduction to ADI and Splitting Schemes Chapter 20: An Introduction to ADI and Splitting Schemes 20.1INTRODUCTION AND OBJECTIVES In this chapter we discuss how to apply finite difference schemes to approximate the solution of multidimensional

More information

A high-order compact method for nonlinear Black-Scholes option pricing equations with transaction costs

A high-order compact method for nonlinear Black-Scholes option pricing equations with transaction costs Technical report, IDE0915, June 2, 2009 A high-order compact method for nonlinear Black-Scholes option pricing equations with transaction costs Master s Thesis in Financial Mathematics Ekaterina Dremkova

More information

Merton s Jump-Diffusion Model

Merton s Jump-Diffusion Model Merton s Jump-Diffusion Model Empirically, stock returns tend to have fat tails, inconsistent with the Black-Scholes model s assumptions. Stochastic volatility and jump processes have been proposed to

More information

Intensity-based framework for optimal stopping

Intensity-based framework for optimal stopping Intensity-based framework for optimal stopping problems Min Dai National University of Singapore Yue Kuen Kwok Hong Kong University of Science and Technology Hong You National University of Singapore Abstract

More information

Economic Dynamic Modeling: An Overview of Stability

Economic Dynamic Modeling: An Overview of Stability Student Projects Economic Dynamic Modeling: An Overview of Stability Nathan Berggoetz Nathan Berggoetz is a senior actuarial science and mathematical economics major. After graduation he plans to work

More information

Infinite Reload Options: Pricing and Analysis

Infinite Reload Options: Pricing and Analysis Infinite Reload Options: Pricing and Analysis A. C. Bélanger P. A. Forsyth April 27, 2006 Abstract Infinite reload options allow the user to exercise his reload right as often as he chooses during the

More information

Systems of Ordinary Differential Equations. Lectures INF2320 p. 1/48

Systems of Ordinary Differential Equations. Lectures INF2320 p. 1/48 Systems of Ordinary Differential Equations Lectures INF2320 p. 1/48 Lectures INF2320 p. 2/48 ystems of ordinary differential equations Last two lectures we have studied models of the form y (t) = F(y),

More information

Evaluation of Asian option by using RBF approximation

Evaluation of Asian option by using RBF approximation Boundary Elements and Other Mesh Reduction Methods XXVIII 33 Evaluation of Asian option by using RBF approximation E. Kita, Y. Goto, F. Zhai & K. Shen Graduate School of Information Sciences, Nagoya University,

More information

Pricing Multi-Dimensional Options by Grid Stretching and High Order Finite Differences

Pricing Multi-Dimensional Options by Grid Stretching and High Order Finite Differences Pricing Multi-Dimensional Options by Gri Stretching an High Orer Finite Differences Kees Oosterlee Numerical Analysis Group, Delft University of Technology Joint work with Coen Leentvaar Southern Ontario

More information

Interest Rate Volatility

Interest Rate Volatility Interest Rate Volatility III. Working with SABR Andrew Lesniewski Baruch College and Posnania Inc First Baruch Volatility Workshop New York June 16-18, 2015 Outline Arbitrage free SABR 1 Arbitrage free

More information

Using Optimal Time Step Selection to Boost the Accuracy of FD Schemes for Variable-Coefficient PDEs

Using Optimal Time Step Selection to Boost the Accuracy of FD Schemes for Variable-Coefficient PDEs Using Optimal Time Step Selection to Boost the Accuracy of FD Schemes for Variable-Coefficient PDEs Kevin T. Chu and James V. Lambers Abstract We extend the technique of optimal time step OTS selection

More information

Computational Methods for Quantitative Finance

Computational Methods for Quantitative Finance Preliminaries Pricing by binomial tree method Models, Algorithms, Numerical Analysis N. Hilber, C. Winter ETHZ-UNIZ Master of Advanced Studies in Finance Spring Term 2008 Scope of the course Preliminaries

More information

A distributed Laplace transform algorithm for European options

A distributed Laplace transform algorithm for European options A distributed Laplace transform algorithm for European options 1 1 A. J. Davies, M. E. Honnor, C.-H. Lai, A. K. Parrott & S. Rout 1 Department of Physics, Astronomy and Mathematics, University of Hertfordshire,

More information

Chapter 7: Constructing smooth forward curves in electricity markets

Chapter 7: Constructing smooth forward curves in electricity markets Chapter 7: Constructing smooth forward curves in electricity markets Presenter: Tony Ware University of Calgary 28th January, 2010 Introduction The goal of this chapter is to represent forward prices by

More information

Computational Finance Finite Difference Methods

Computational Finance Finite Difference Methods Explicit finite difference method Computational Finance Finite Difference Methods School of Mathematics 2018 Today s Lecture We now introduce the final numerical scheme which is related to the PDE solution.

More information

FINITE DIFFERENCE METHODS

FINITE DIFFERENCE METHODS FINITE DIFFERENCE METHODS School of Mathematics 2013 OUTLINE Review 1 REVIEW Last time Today s Lecture OUTLINE Review 1 REVIEW Last time Today s Lecture 2 DISCRETISING THE PROBLEM Finite-difference approximations

More information

Computational Finance

Computational Finance Computational Finance Raul Kangro Fall 016 Contents 1 Options on one underlying 4 1.1 Definitions and examples.......................... 4 1. Strange things about pricing options.................... 5

More information

Finite Difference Methods for Option Pricing

Finite Difference Methods for Option Pricing Finite Difference Methods for Option Pricing Muhammad Usman, Ph.D. University of Dayton CASM Workshop - Black Scholes and Beyond: Pricing Equity Derivatives LUMS, Lahore, Pakistan, May 16 18, 2014 Outline

More information

MAFS Computational Methods for Pricing Structured Products

MAFS Computational Methods for Pricing Structured Products MAFS550 - Computational Methods for Pricing Structured Products Solution to Homework Two Course instructor: Prof YK Kwok 1 Expand f(x 0 ) and f(x 0 x) at x 0 into Taylor series, where f(x 0 ) = f(x 0 )

More information

A Comparative Study of Black-Scholes Equation

A Comparative Study of Black-Scholes Equation Selçuk J. Appl. Math. Vol. 10. No. 1. pp. 135-140, 2009 Selçuk Journal of Applied Mathematics A Comparative Study of Black-Scholes Equation Refet Polat Department of Mathematics, Faculty of Science and

More information

Reduced models for sparse grid discretizations of the multi-asset Black-Scholes equation

Reduced models for sparse grid discretizations of the multi-asset Black-Scholes equation Reduced models for sparse grid discretizations of the multi-asset Black-Scholes equation The MIT Faculty has made this article openly available. Please share how this access benefits you. Your story matters.

More information

Sparse Wavelet Methods for Option Pricing under Lévy Stochastic Volatility models

Sparse Wavelet Methods for Option Pricing under Lévy Stochastic Volatility models Sparse Wavelet Methods for Option Pricing under Lévy Stochastic Volatility models Norbert Hilber Seminar of Applied Mathematics ETH Zürich Workshop on Financial Modeling with Jump Processes p. 1/18 Outline

More information

Contents Critique 26. portfolio optimization 32

Contents Critique 26. portfolio optimization 32 Contents Preface vii 1 Financial problems and numerical methods 3 1.1 MATLAB environment 4 1.1.1 Why MATLAB? 5 1.2 Fixed-income securities: analysis and portfolio immunization 6 1.2.1 Basic valuation of

More information

NUMERICAL AND SIMULATION TECHNIQUES IN FINANCE

NUMERICAL AND SIMULATION TECHNIQUES IN FINANCE NUMERICAL AND SIMULATION TECHNIQUES IN FINANCE Edward D. Weinberger, Ph.D., F.R.M Adjunct Assoc. Professor Dept. of Finance and Risk Engineering edw2026@nyu.edu Office Hours by appointment This half-semester

More information

Black-Scholes Models with Inherited Time and Price Memory

Black-Scholes Models with Inherited Time and Price Memory Black-Scholes Models with Inherited Time and Price Memory Mahmoud Ali Jaradat To Link this Article: http://dx.doi.org/10.6007/ijarbss/v8-i12/5180 DOI: 10.6007/IJARBSS/v8-i12/5180 Received: 02 Nov 2018,

More information

Techniques for Calculating the Efficient Frontier

Techniques for Calculating the Efficient Frontier Techniques for Calculating the Efficient Frontier Weerachart Kilenthong RIPED, UTCC c Kilenthong 2017 Tee (Riped) Introduction 1 / 43 Two Fund Theorem The Two-Fund Theorem states that we can reach any

More information

Appendix G: Numerical Solution to ODEs

Appendix G: Numerical Solution to ODEs Appendix G: Numerical Solution to ODEs The numerical solution to any transient problem begins with the derivation of the governing differential equation, which allows the calculation of the rate of change

More information

A new PDE approach for pricing arithmetic average Asian options

A new PDE approach for pricing arithmetic average Asian options A new PDE approach for pricing arithmetic average Asian options Jan Večeř Department of Mathematical Sciences, Carnegie Mellon University, Pittsburgh, PA 15213. Email: vecer@andrew.cmu.edu. May 15, 21

More information

Fluctuations. Shocks, Uncertainty, and the Consumption/Saving Choice

Fluctuations. Shocks, Uncertainty, and the Consumption/Saving Choice Fluctuations. Shocks, Uncertainty, and the Consumption/Saving Choice Olivier Blanchard April 2005 14.452. Spring 2005. Topic2. 1 Want to start with a model with two ingredients: Shocks, so uncertainty.

More information

King s College London

King s College London King s College London University Of London This paper is part of an examination of the College counting towards the award of a degree. Examinations are governed by the College Regulations under the authority

More information

1 No capital mobility

1 No capital mobility University of British Columbia Department of Economics, International Finance (Econ 556) Prof. Amartya Lahiri Handout #7 1 1 No capital mobility In the previous lecture we studied the frictionless environment

More information

4 Finite Difference Methods

4 Finite Difference Methods 4 Finite Difference Methods 4.1 Introduction 4.1.1 Security Pricing and Partial Differential Equations We have seen in a previous chapter that the arbitrage-free price of a European-style contingent claim

More information

PROJECT REPORT. Dimension Reduction for the Black-Scholes Equation. Alleviating the Curse of Dimensionality

PROJECT REPORT. Dimension Reduction for the Black-Scholes Equation. Alleviating the Curse of Dimensionality Dimension Reduction for the Black-Scholes Equation Alleviating the Curse of Dimensionality Erik Ekedahl, Eric Hansander and Erik Lehto Report in Scientic Computing, Advanced Course June 2007 PROJECT REPORT

More information

Lecture 8: Linear Prediction: Lattice filters

Lecture 8: Linear Prediction: Lattice filters 1 Lecture 8: Linear Prediction: Lattice filters Overview New AR parametrization: Reflection coefficients; Fast computation of prediction errors; Direct and Inverse Lattice filters; Burg lattice parameter

More information

Pricing Dynamic Solvency Insurance and Investment Fund Protection

Pricing Dynamic Solvency Insurance and Investment Fund Protection Pricing Dynamic Solvency Insurance and Investment Fund Protection Hans U. Gerber and Gérard Pafumi Switzerland Abstract In the first part of the paper the surplus of a company is modelled by a Wiener process.

More information

Estimating Market Power in Differentiated Product Markets

Estimating Market Power in Differentiated Product Markets Estimating Market Power in Differentiated Product Markets Metin Cakir Purdue University December 6, 2010 Metin Cakir (Purdue) Market Equilibrium Models December 6, 2010 1 / 28 Outline Outline Estimating

More information

Modeling multi-factor financial derivatives by a Partial Differential Equation approach with efficient implementation on Graphics Processing Units

Modeling multi-factor financial derivatives by a Partial Differential Equation approach with efficient implementation on Graphics Processing Units Modeling multi-factor financial derivatives by a Partial Differential Equation approach with efficient implementation on Graphics Processing Units by Duy Minh Dang A thesis submitted in conformity with

More information

WKB Method for Swaption Smile

WKB Method for Swaption Smile WKB Method for Swaption Smile Andrew Lesniewski BNP Paribas New York February 7 2002 Abstract We study a three-parameter stochastic volatility model originally proposed by P. Hagan for the forward swap

More information

Preferences - A Reminder

Preferences - A Reminder Chapter 4 Utility Preferences - A Reminder x y: x is preferred strictly to y. p x ~ y: x and y are equally preferred. f ~ x y: x is preferred at least as much as is y. Preferences - A Reminder Completeness:

More information

Final Exam Key, JDEP 384H, Spring 2006

Final Exam Key, JDEP 384H, Spring 2006 Final Exam Key, JDEP 384H, Spring 2006 Due Date for Exam: Thursday, May 4, 12:00 noon. Instructions: Show your work and give reasons for your answers. Write out your solutions neatly and completely. There

More information

PDE Methods for Option Pricing under Jump Diffusion Processes

PDE Methods for Option Pricing under Jump Diffusion Processes PDE Methods for Option Pricing under Jump Diffusion Processes Prof Kevin Parrott University of Greenwich November 2009 Typeset by FoilTEX Summary Merton jump diffusion American options Levy Processes -

More information

So far in the short-run analysis we have ignored the wage and price (we assume they are fixed).

So far in the short-run analysis we have ignored the wage and price (we assume they are fixed). Chapter 7: Labor Market So far in the short-run analysis we have ignored the wage and price (we assume they are fixed). Key idea: In the medium run, rising GD will lead to lower unemployment rate (more

More information

Chapter DIFFERENTIAL EQUATIONS: PHASE SPACE, NUMERICAL SOLUTIONS

Chapter DIFFERENTIAL EQUATIONS: PHASE SPACE, NUMERICAL SOLUTIONS Chapter 10 10. DIFFERENTIAL EQUATIONS: PHASE SPACE, NUMERICAL SOLUTIONS Abstract Solving differential equations analytically is not always the easiest strategy or even possible. In these cases one may

More information

Estimating Bivariate GARCH-Jump Model Based on High Frequency Data : the case of revaluation of Chinese Yuan in July 2005

Estimating Bivariate GARCH-Jump Model Based on High Frequency Data : the case of revaluation of Chinese Yuan in July 2005 Estimating Bivariate GARCH-Jump Model Based on High Frequency Data : the case of revaluation of Chinese Yuan in July 2005 Xinhong Lu, Koichi Maekawa, Ken-ichi Kawai July 2006 Abstract This paper attempts

More information

f(u) can take on many forms. Several of these forms are presented in the following examples. dx, x is a variable.

f(u) can take on many forms. Several of these forms are presented in the following examples. dx, x is a variable. MATH 56: INTEGRATION USING u-du SUBSTITUTION: u-substitution and the Indefinite Integral: An antiderivative of a function f is a function F such that F (x) = f (x). Any two antiderivatives of f differ

More information

Lecture 4. Finite difference and finite element methods

Lecture 4. Finite difference and finite element methods Finite difference and finite element methods Lecture 4 Outline Black-Scholes equation From expectation to PDE Goal: compute the value of European option with payoff g which is the conditional expectation

More information

5 Numerical Solution of Linear Systems

5 Numerical Solution of Linear Systems 5 Numerical Solution of Linear Systems In this chapter we present several methods for solving linear systems of the form Ax = b. HereA is a (m m) matrix and both x and b are m-dimensional vectors. Our

More information

A Componentwise Splitting Method for Pricing American Options under the Bates Model

A Componentwise Splitting Method for Pricing American Options under the Bates Model A Componentwise Splitting Method for Pricing American Options under the Bates Model Jari Toivanen Abstract A linear complementarity problem LCP) is formulated for the price of American options under the

More information

American Equity Option Valuation Practical Guide

American Equity Option Valuation Practical Guide Valuation Practical Guide John Smith FinPricing Summary American Equity Option Introduction The Use of American Equity Options Valuation Practical Guide A Real World Example American Option Introduction

More information

Optimal Investment Policy for Real Option Problems with Regime Switching

Optimal Investment Policy for Real Option Problems with Regime Switching The Sixth International Symposium on Operations Research and Its Applications (ISORA 06) Xinjiang, China, August 8 1, 006 Copyright 006 ORSC & APORC pp. 35 46 Optimal Investment Policy for Real Option

More information

Chapter II: Labour Market Policy

Chapter II: Labour Market Policy Chapter II: Labour Market Policy Section 2: Unemployment insurance Literature: Peter Fredriksson and Bertil Holmlund (2001), Optimal unemployment insurance in search equilibrium, Journal of Labor Economics

More information

Midterm 1, Financial Economics February 15, 2010

Midterm 1, Financial Economics February 15, 2010 Midterm 1, Financial Economics February 15, 2010 Name: Email: @illinois.edu All questions must be answered on this test form. Question 1: Let S={s1,,s11} be the set of states. Suppose that at t=0 the state

More information

STOCHASTIC INTEGRALS

STOCHASTIC INTEGRALS Stat 391/FinMath 346 Lecture 8 STOCHASTIC INTEGRALS X t = CONTINUOUS PROCESS θ t = PORTFOLIO: #X t HELD AT t { St : STOCK PRICE M t : MG W t : BROWNIAN MOTION DISCRETE TIME: = t < t 1

More information

Computational Methods in Finance

Computational Methods in Finance Chapman & Hall/CRC FINANCIAL MATHEMATICS SERIES Computational Methods in Finance AM Hirsa Ltfi) CRC Press VV^ J Taylor & Francis Group Boca Raton London New York CRC Press is an imprint of the Taylor &

More information

Final exam solutions

Final exam solutions EE365 Stochastic Control / MS&E251 Stochastic Decision Models Profs. S. Lall, S. Boyd June 5 6 or June 6 7, 2013 Final exam solutions This is a 24 hour take-home final. Please turn it in to one of the

More information

Dynamic Replication of Non-Maturing Assets and Liabilities

Dynamic Replication of Non-Maturing Assets and Liabilities Dynamic Replication of Non-Maturing Assets and Liabilities Michael Schürle Institute for Operations Research and Computational Finance, University of St. Gallen, Bodanstr. 6, CH-9000 St. Gallen, Switzerland

More information

3.4 Copula approach for modeling default dependency. Two aspects of modeling the default times of several obligors

3.4 Copula approach for modeling default dependency. Two aspects of modeling the default times of several obligors 3.4 Copula approach for modeling default dependency Two aspects of modeling the default times of several obligors 1. Default dynamics of a single obligor. 2. Model the dependence structure of defaults

More information

Some Numerical Methods for. Options Valuation

Some Numerical Methods for. Options Valuation Communications in Mathematical Finance, vol.1, no.1, 2012, 51-74 ISSN: 2241-1968 (print), 2241-195X (online) Scienpress Ltd, 2012 Some Numerical Methods for Options Valuation C.R. Nwozo 1 and S.E. Fadugba

More information

Queens College, CUNY, Department of Computer Science Computational Finance CSCI 365 / 765 Fall 2017 Instructor: Dr. Sateesh Mane.

Queens College, CUNY, Department of Computer Science Computational Finance CSCI 365 / 765 Fall 2017 Instructor: Dr. Sateesh Mane. Queens College, CUNY, Department of Computer Science Computational Finance CSCI 365 / 765 Fall 217 Instructor: Dr. Sateesh Mane c Sateesh R. Mane 217 13 Lecture 13 November 15, 217 Derivation of the Black-Scholes-Merton

More information

6.4 Solving Linear Inequalities by Using Addition and Subtraction

6.4 Solving Linear Inequalities by Using Addition and Subtraction 6.4 Solving Linear Inequalities by Using Addition and Subtraction Solving EQUATION vs. INEQUALITY EQUATION INEQUALITY To solve an inequality, we USE THE SAME STRATEGY AS FOR SOLVING AN EQUATION: ISOLATE

More information

Estimating Maximum Smoothness and Maximum. Flatness Forward Rate Curve

Estimating Maximum Smoothness and Maximum. Flatness Forward Rate Curve Estimating Maximum Smoothness and Maximum Flatness Forward Rate Curve Lim Kian Guan & Qin Xiao 1 January 21, 22 1 Both authors are from the National University of Singapore, Centre for Financial Engineering.

More information

Pricing Algorithms for financial derivatives on baskets modeled by Lévy copulas

Pricing Algorithms for financial derivatives on baskets modeled by Lévy copulas Pricing Algorithms for financial derivatives on baskets modeled by Lévy copulas Christoph Winter, ETH Zurich, Seminar for Applied Mathematics École Polytechnique, Paris, September 6 8, 26 Introduction

More information

Pricing American Options Using a Space-time Adaptive Finite Difference Method

Pricing American Options Using a Space-time Adaptive Finite Difference Method Pricing American Options Using a Space-time Adaptive Finite Difference Method Jonas Persson Abstract American options are priced numerically using a space- and timeadaptive finite difference method. The

More information

induced by the Solvency II project

induced by the Solvency II project Asset Les normes allocation IFRS : new en constraints assurance induced by the Solvency II project 36 th International ASTIN Colloquium Zürich September 005 Frédéric PLANCHET Pierre THÉROND ISFA Université

More information