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

Size: px
Start display at page:

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

Transcription

1 AEM 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 16, 2002

2 ABSTRACT The primary purpose of this work was to become familiar with numerical techniques, namely finite difference schemes, available for solving parabolic partial differential equations (PDEs) such as the governing equation for viscous diffusion. An application of such viscous diffusion is the transient flow problem. This problem is investigated here and the various finite difference schemes are applied to solve this problem for various time steps. These schemes include the FTCS, Crank-Nicholson, DuFort Frankel (explicit) and IMPLICIT finite difference schemes. For the FTCS scheme, stability is examined and indicated the numerical scheme to be conditionally stable. The results indicate that the FTCS scheme is conditionally stable while the Crank-Nicholson and DuFort-Frankel schemes are unconditionally stable. This realization allows for selection of the best scheme for implementation in solving this problem. INTRODUCTION Background The Flow problem is classic example of viscous diffusion. The governing equation for such problem was derived using boundary layer theory to reduce the full Navier- Stokes equations to the single parabolic PDE,. with the necessary initial and boundary conditions, t = 0: u(0) = 0, u(0.04m) = 0; t > 0: u(0) = 40.0, u(0.04m) = U = 0.0m/s. This problem may be described physically as transient viscous-driven flow between two plates of infinite extent and separated by a distance of 0.04m. Initially both plates are at rest. After time,t=0, the upper plate is set in motion in the positive x-direction with a velocity of 40.0m/s. Due to the viscosity of the fluid filling the space between the plates, successive lamina of fluid are set in motion as time elapses. Eventually, the system reaches a quasi-steady state, as the velocity profile becomes more or less constant in time. The governing equation lends nicely to the use of finite difference techniques to solve the problem in the transient domain. Solution Techniques Part 1: FTCS Finite Difference Scheme: The FTCS (Forward Time Centered Space) explicit finite difference scheme for the diffusion equation may be written as

3 Stability may be examined using the Von Neumman stability analysis. This analysis was completed and is included as appendix B. The results indicate that the FTSC explicit scheme is conditionally stable. That is the scheme is stable provided R less then half or 1/2. Part 2: Crank-Nicholson Finite Difference Scheme: The Crank-Nicholson scheme is an implicit and unconditionally stable scheme that may bewritten as,, In this case the coefficients on the LHS are known and the entire RHS is known at each time step. Thus, the scheme may be written in matrix form as a tridiagonal system of equations that can be subsequently solved at each time step using Numerical Recipes1, TRIDAG. Part 3: DuFort-Frankel (Explicit ) Scheme The DuFort-Frankel explicit scheme, also unconditionally stable, may be written as ujn+1 = [2R/(1+2R)](uj+ n + uj- n) + [(1-2R)/(1+2R)] ujn-1 Part 4: The IMPLICIT scheme for this problem may be written as Ruj- n+1 2(1 + R) n+1 + n+1 = - ujn Again, this scheme is unconditionally stable and as is easily seen can also be solved using the tridiagonalmatrix method of Numerical Recipes1, TRIDAG.In all of the cases above, Each of the above numerical schemes was used to solve the viscous diffusion problem for various values of T. Th value of R = for all cases and Time T = 0.18, T = 0.36, T= The FORTRAN code used to implement these schemes is included as appendix B. Code for the Crank Nicolson scheme was giving a plot which was not accurate, so I decided to write code in MAtlab and it gave fine results. RESULTS AND DISCUSSION The results of each case investigated are presented in the distabce covere by the velocity of the fluid, where u is the velocity computed for each spatial grid point

4 Similarly, y is the distance between spatial grid points and the plate separation is m. These plots represent the velocity profiles computed at 3 different time steps and illustrate the transient nature of the solution for each case. Part 1: FTCS Finite Difference Scheme The results of the stability analysis indicate that the FTCS scheme is stable provided R < ½. Thus, it was apparent that the solution for the case, Since in our case R is constant and is equal to 0.217, hence the solution is stable and the results are presented as figure 1. This plot represents the velocity profiles for three time steps from t=0.18, t= 0.36 and t = In this case one would expect the velocity to be zero beyond certain points across the separation distance until the viscous diffusion has reached the lower plate. This can actually be seen by inspection of the raw output data file. In any case, it is obvious that numerical stability must be investigated to ensure a quality solution to the problem at hand and if instability is predicted, an alternate scheme should be considered. Part 2: Crank-Nicholson Finite Difference Scheme Unlike the FTCS scheme, the Crank-Nicholson finite difference scheme has the primary advantage of being unconditionally stable for all possible values of R and hence having a greater range of application than the previous FTCS scheme. Results are very similar in shape to those obtained using FTCS scheme. Part 3: DuFort-Frankel (Explicit) Scheme: The DuFort-Frankel explicit scheme (also unconditionally stable) generates results similar to the FTCS scheme Figure 3 is much like figure 1 as expected since the time steps are the same. Part 4: The IMPLICIT scheme: Finally, the fully implicit scheme was used to solve this problem. Figure 2 represents the results presented in the same manner as previously described. One would expect the results to look similar to the previous cases. The results are more or less similar. Unlike the explicit scheme which has accuracy of O(Dt2), the accuracy is reduced to O(Dt). The little difference is seen in accuracy of the solution because of this. CONCLUSIONS Based on the results of the Von Neumann stability analysis, the FTCS scheme is conditionally stable. That is numerical stability can only be achieved for R < 0.5. In contrast, the Crank-Nicholson and DuFort-Frankel schemes provide unconditional stability and hence allow for solutions corresponding with various values of R. The primary advantages of unconditional stability are improved efficiency and accuracy as larger time steps may be used to converge to a solution in fewer time iterations and hence reduce the truncation error associated with the time domain. The results of this investigation demonstrate the importance of choosing the appropriate scheme for the problem at hand. In

5 addition, these results provide a nice survey of those techniques available for solving parabolic PDEs such as the diffusion equation and the advantages/disadvantages associated with each. One aspect of Numerical Computation that was learned here (definitely the hard way) was that it is always better to write different subroutines and then put them in a project together. However I tried to do that, but could not do that because of the debugging problem. This was first time to write programs in Fortran, hopefully in later stages things will be easy to do.

6 APPENDIX A: Plots for the four schemes: 1. Plot for FTCS Explicit Scheme VELOCITY : FTCS EXPLICIT SCHEME VELOCITY T = 0.18 T = 0.36 T = For T = 0.18 T = 0.36 T = LENGTH

7 2. Plot for FTCS IMPLICIT Scheme VELOCITY RESULTS: IMPLICIT SCHEME VELOCITY T = 0.18 T = 0.36 T = LENGTH For T = 0.18 T = 0.36 T = 1.08

8 3. Plot for FTCS DUFORT-FRANKEL Scheme VELOCITY RESULTS: DUFORT FRANKEL SCHEME Velocity T =1.08 T = 0.36 T = Length For T = 0.18 T = 0.36 T = 1.08

9 4. Plot for CRANK - NICHOLSON Scheme For T = 0.18 T = 0.36 T = 1.08

10 APPENDIX B: COMPUTER CODE FOR SCHEMES. 1. Computer Code in Fortran for FTCS EXPLICIT SCHEME. Homework#1 - FTCS EXPLICIT METHOD Program computes the numerical solution to the Transient Flow Problem. The following initial and bounadry conditions are applied: t=0: u(y=0)=40.0m/s t>0: u(y=0)=0.0; u(y=0.04m)=0.0 parameter(maxn=42,eps=1.0e-3) integer m,mm,count real*8 u_old(maxn),u_new(maxn),y(maxn) real*8 t,tau,h,r,tmax,u_init,nu,sum,error data h,m,u_init,nu,r,tmax /0.001,41,0.0,2.17e-4,0.217,2.5e5/ open(unit=1,file='hw1_explicit.out',status='unknown') tau=r*h**2/nu mm=m-1 error=1.0 count=0 t=0.0 y(1)=0.0 do 2 i=2,m y(i)=y(i-1)+h 2 continue do 3 i=1,mm u_old(1)= continue u_old(m)=0.0 write(1,*)'velocity Results:' write(1,10)t,(u_old(j),j=1,m) do while count=count+1 sum=0.0 t=t+tau do 4 i=2,mm u_new(i)=u_old(i)+r*(u_old(i-1)-2.0*u_old(i)+u_old(i+1))

11 end do 10 format(2x,f10.3,5x,41f8.4) write(1,'(" Number of steps for convergence = ",i4)')count end 2. Computer Code in Fortran for FTCS IMPLICIT SCHEME. Homework#1 - FTCS IMPLICIT METHOD MODULE VARIABLE PARAMETER (NX=45, NY=45) Declaration of constant parameters PARAMETER t = 2, dt = 0.002, y = 0.04, dy = 0.001, nu = , term = nu*dt/(dy*dy) Declaration for the integer variables INTEGER i, j INTEGER tmax = (t/dt) + 1, ymax = (y/dy)+1 Declaration for the real array variables REAL, DIMENSION(NX) :: a, b, c,d, h, g REAL, DIMENSION(NX,NY) :: u END MODULE VARIABLE PROGRAM IMPLICIT USE VARIABLE CALL INITIAL(u) CALL BOUNDARY(u) CALL LASONNEN(u) END PROGRAM Subroutine for boundary conditions SUBROUTINE BOUNDARY(u) USE VARIABLE DO j=1,tmax u(j,1) = 40 u(j,41) = 0

12 END DO END SUBROUTINE END of subroutine SUBROUTINE LASONNEN(u) USE VARIABLE DO j=2,tmax DO i=2,ymax-1 a(i) = term b(i) = -(1+2*term) c(i) = term d(i) = u(j-1,i) END DO CALL TRIDIAGONAL(a,b,c,d,u,j) IF j = 91.OR. 181.OR. 271.OR. 361.OR. 451.OR. 541 CALL OUTPUT END DO END SUBROUTINE Subroutine for initializing arrays SUBROUTINE INITIAL(u) USE VARIABLE DO i=1,ymax u(1,i) = 0 u(1,1)= 40 END DO END SUBROUTINE END of subroutine SUBROUTINE TRIDIAGONAL(a,b,c,d,u,j) h(1) = 0 g(1) = 40 DO i=2,ymax-1 h(i) = c(i)/(b(i)-a(i)*h(i-1)) g(i) = (d(i)-a(i)*g(i-1))/(b(i)-a(i)*h(i-1)) END DO CALL CALCU(g,h,u,j)

13 END SUBROUTINE SUBROUTINE OUTPUT USE VARIABLE OPEN (UNIT=1,FILE='FILEOUT1.DAT') DO i=1, ymax WRITE (1,100)(u(i)) 101 FORMAT (41F10.3) END DO END SUBROUTINE 3. Computer Code in Fortran for DUFORT FRANKEL SCHEME. Homework1 DUFORT FRANKE SCHEME Program computes the numerical solution to the Transient Flow Problem. The following initial and bounadry conditions are applied: t=0: u(y=0)=40.0m/s t>0: u(y=0)=0.0; u(y=0.04m)=0.0 parameter(maxn=30,eps=1.0e-3) integer k,m,mm,count real*8 u_old(1001,maxn),u_new(1001,maxn),y(maxn) real*8 t,tau,h,r,tmax,u_init,nu,sum,error data h,m,u_init,nu,r,tmax /0.001,41,0.0,2.17e-4,0.217,2.5e5/ open(unit=1,file='hw1_dufort.out',status='unknown') tau=r*h**2/nu mm=m-1 error=1.0 count=0 k=1 t=0.0 y(1)=0.0 do 2 i=2,m y(i)=y(i-1)+h

14 2 continue write(1,*)'velocity Results:' write(1,10)t,(u_old(k,j),j=1,m) do while ((error.gt.eps).and.(count.lt.1080)) count=count+1 sum=0.0 t=t+tau u_old(k,1)=40.0 u_old(k,m)=0.0 do 4 i=2,mm if (k.lt.2) then u_new(k,i)=(2.0*r/( *r))*(u_old(k,i+1)+u_old(k,i-1)) else u_new(k,i)=(2.0*r/( *r))*(u_old(k,i+1)+u_old(k,i-1))+ (( *r)/( *r))*u_old(k-1,i) end if end do 10 format(2x,f10.3,2x,41f8.4) write(1,'(" Number of steps for convergence = ",i4)')count end 4. Computer Code in MATLAB for CRANK NICOLSON SCHEME. m=1080;n=41; dt=0.001; dx=0.001; a= ; h=0.5*(a*dt)/(dx^2); u = zeros(41,1080); u(1,1:1080) =40; u(41,1:1080) = 0; u(1:41,1080) = 0; u(1,1) = 40; for j =2:m for i =2:n-1 a1(i)=h; b1(i)=-1-2*h; c1(i)=h; d1(i)=-u(i,j-1)-h*(u(i+1,j-1)-2*u(i,j-1)+u(i-1,j-1)); end s(1)= 0;

15 t(1)=u(1,j-1); for i =2:n-1 s(i)=c1(i)/(b1(i)-a1(i)*s(i-1)); t(i)=(d1(i)-a1(i)*t(i-1))/(b1(i)-a1(i)*s(i-1)); end val(n)=0; for i =n-1:-1:2 val(i)=-s(i)*u(i+1,j-1)+t(i); end for i=2:n-1 u(i,j)=val(i); end end figure(1) for i = 300:300:1080 plot(0:0.001:0.04,u(:,i),'black'); hold on; end APPENDIX C: ERROR VECTOR for Explicit Scheme at T = 0.18 sec and for dt = Exact Solution T = 1.08 sec Numerical Solution y(m) Explicit EXPLICIT ERROR

16 FOR T = 1.08 for dt = Exact Solution Numerical Solution y(m) Explicit Explicit ERROR

17

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

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

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

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

Lecture 20 Heat Equation and Parabolic Problems

Lecture 20 Heat Equation and Parabolic Problems .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

More information

Boise State University GEOS 397 Fall 2016

Boise State University GEOS 397 Fall 2016 Homework #3: Hill-slope evolution and plotting Due: 5:00 PM 09/16/16 Please read the following questions carefully and make sure to answer the problems completely. In your MATLAB script(s), please include

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

(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

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

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

A Study on Numerical Solution of Black-Scholes Model

A Study on Numerical Solution of Black-Scholes Model Journal of Mathematical Finance, 8, 8, 37-38 http://www.scirp.org/journal/jmf ISSN Online: 6-44 ISSN Print: 6-434 A Study on Numerical Solution of Black-Scholes Model Md. Nurul Anwar,*, Laek Sazzad Andallah

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

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

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

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

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

Partial Differential Equations of Fluid Dynamics

Partial Differential Equations of Fluid Dynamics Partial Differential Equations of Fluid Dynamics Ville Vuorinen,D.Sc.(Tech.) 1 1 Department of Energy Technology, Internal Combustion Engine Research Group Department of Energy Technology Outline Introduction

More information

An IMEX-method for pricing options under Bates model using adaptive finite differences Rapport i Teknisk-vetenskapliga datorberäkningar

An IMEX-method for pricing options under Bates model using adaptive finite differences Rapport i Teknisk-vetenskapliga datorberäkningar PROJEKTRAPPORT An IMEX-method for pricing options under Bates model using adaptive finite differences Arvid Westlund Rapport i Teknisk-vetenskapliga datorberäkningar Jan 2014 INSTITUTIONEN FÖR INFORMATIONSTEKNOLOGI

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

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

Package multiassetoptions

Package multiassetoptions Package multiassetoptions February 20, 2015 Type Package Title Finite Difference Method for Multi-Asset Option Valuation Version 0.1-1 Date 2015-01-31 Author Maintainer Michael Eichenberger

More information

Exam in TFY4275/FY8907 CLASSICAL TRANSPORT THEORY Feb 14, 2014

Exam in TFY4275/FY8907 CLASSICAL TRANSPORT THEORY Feb 14, 2014 NTNU Page 1 of 5 Institutt for fysikk Contact during the exam: Professor Ingve Simonsen Exam in TFY4275/FY8907 CLASSICAL TRANSPORT THEORY Feb 14, 2014 Allowed help: Alternativ D All written material This

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

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

MATH60082 Example Sheet 6 Explicit Finite Difference

MATH60082 Example Sheet 6 Explicit Finite Difference MATH68 Example Sheet 6 Explicit Finite Difference Dr P Johnson Initial Setup For the explicit method we shall need: All parameters for the option, such as X and S etc. The number of divisions in stock,

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

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

CRANK-NICOLSON SCHEME FOR ASIAN OPTION

CRANK-NICOLSON SCHEME FOR ASIAN OPTION CRANK-NICOLSON SCHEME FOR ASIAN OPTION By LEE TSE YUENG A thesis submitted to the Department of Mathematical and Actuarial Sciences, Faculty of Engineering and Science, Universiti Tunku Abdul Rahman, 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

A Note on Ramsey, Harrod-Domar, Solow, and a Closed Form

A Note on Ramsey, Harrod-Domar, Solow, and a Closed Form A Note on Ramsey, Harrod-Domar, Solow, and a Closed Form Saddle Path Halvor Mehlum Abstract Following up a 50 year old suggestion due to Solow, I show that by including a Ramsey consumer in the Harrod-Domar

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 The Solow Growth Model

1 The Solow Growth Model 1 The Solow Growth Model The Solow growth model is constructed around 3 building blocks: 1. The aggregate production function: = ( ()) which it is assumed to satisfy a series of technical conditions: (a)

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

Phys. Lett. A, 372/17, (2008),

Phys. Lett. A, 372/17, (2008), Phys. Lett. A, 372/17, (2008), 3064-3070. 1 Wave scattering by many small particles embedded in a medium. A. G. Ramm (Mathematics Department, Kansas State University, Manhattan, KS66506, USA and TU Darmstadt,

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

Structure of the Code

Structure of the Code NSCool User s guide Structure of the Code Dany Page Instituto de Astronomía Universidad Nacional Autónoma de México 1 The problem to be solved The equations to be solved are described in the NSCool_Guide_1

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

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

Numerical schemes for SDEs

Numerical schemes for SDEs Lecture 5 Numerical schemes for SDEs Lecture Notes by Jan Palczewski Computational Finance p. 1 A Stochastic Differential Equation (SDE) is an object of the following type dx t = a(t,x t )dt + b(t,x t

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

ZABR -- Expansions for the Masses

ZABR -- Expansions for the Masses ZABR -- Expansions for the Masses Preliminary Version December 011 Jesper Andreasen and Brian Huge Danse Marets, Copenhagen want.daddy@danseban.com brno@danseban.com 1 Electronic copy available at: http://ssrn.com/abstract=198076

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

Numerical Solution of Two Asset Jump Diffusion Models for Option Valuation

Numerical Solution of Two Asset Jump Diffusion Models for Option Valuation Numerical Solution of Two Asset Jump Diffusion Models for Option Valuation Simon S. Clift and Peter A. Forsyth Original: December 5, 2005 Revised: January 31, 2007 Abstract Under the assumption that two

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

MODELING DEFAULTABLE BONDS WITH MEAN-REVERTING LOG-NORMAL SPREAD: A QUASI CLOSED-FORM SOLUTION

MODELING DEFAULTABLE BONDS WITH MEAN-REVERTING LOG-NORMAL SPREAD: A QUASI CLOSED-FORM SOLUTION MODELING DEFAULTABLE BONDS WITH MEAN-REVERTING LOG-NORMAL SPREAD: A QUASI CLOSED-FORM SOLUTION Elsa Cortina a a Instituto Argentino de Matemática (CONICET, Saavedra 15, 3er. piso, (1083 Buenos Aires, Agentina,elsa

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

Math Computational Finance Barrier option pricing using Finite Difference Methods (FDM)

Math Computational Finance Barrier option pricing using Finite Difference Methods (FDM) . Math 623 - Computational Finance Barrier option pricing using Finite Difference Methods (FDM) Pratik Mehta pbmehta@eden.rutgers.edu Masters of Science in Mathematical Finance Department of Mathematics,

More information

Lab12_sol. November 21, 2017

Lab12_sol. November 21, 2017 Lab12_sol November 21, 2017 1 Sample solutions of exercises of Lab 12 Suppose we want to find the current prices of an European option so that the error at the current stock price S(0) = S 0 was less that

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

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

Richardson Extrapolation Techniques for the Pricing of American-style Options

Richardson Extrapolation Techniques for the Pricing of American-style Options Richardson Extrapolation Techniques for the Pricing of American-style Options June 1, 2005 Abstract Richardson Extrapolation Techniques for the Pricing of American-style Options In this paper we re-examine

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

MASM006 UNIVERSITY OF EXETER SCHOOL OF ENGINEERING, COMPUTER SCIENCE AND MATHEMATICS MATHEMATICAL SCIENCES FINANCIAL MATHEMATICS.

MASM006 UNIVERSITY OF EXETER SCHOOL OF ENGINEERING, COMPUTER SCIENCE AND MATHEMATICS MATHEMATICAL SCIENCES FINANCIAL MATHEMATICS. MASM006 UNIVERSITY OF EXETER SCHOOL OF ENGINEERING, COMPUTER SCIENCE AND MATHEMATICS MATHEMATICAL SCIENCES FINANCIAL MATHEMATICS May/June 2006 Time allowed: 2 HOURS. Examiner: Dr N.P. Byott This is a CLOSED

More information

JUMPS WITHOUT TEARS: A NEW SPLITTING TECHNOLOGY FOR BARRIER OPTIONS

JUMPS WITHOUT TEARS: A NEW SPLITTING TECHNOLOGY FOR BARRIER OPTIONS INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume, Number, Pages c Institute for Scientific Computing and Information JUMPS WITHOUT TEARS: A NEW SPLITTING TECHNOLOGY FOR BARRIER OPTIONS ANDREY

More information

American Options; an American delayed- Exercise model and the free boundary. Business Analytics Paper. Nadra Abdalla

American Options; an American delayed- Exercise model and the free boundary. Business Analytics Paper. Nadra Abdalla American Options; an American delayed- Exercise model and the free boundary Business Analytics Paper Nadra Abdalla [Geef tekst op] Pagina 1 Business Analytics Paper VU University Amsterdam Faculty of Sciences

More information

Partitioned Analysis of Coupled Systems

Partitioned Analysis of Coupled Systems Partitioned Analysis of Coupled Systems Hermann G. Matthies, Rainer Niekamp, Jan Steindorf Technische Universität Braunschweig Brunswick, Germany wire@tu-bs.de http://www.wire.tu-bs.de Coupled Problems

More information

Numerical Methods for PDEs : Video 8: Finite Difference February Expressions 7, 2015 & Error 1 / Part 12

Numerical Methods for PDEs : Video 8: Finite Difference February Expressions 7, 2015 & Error 1 / Part 12 22.520 Numerical Methods for PDEs : Video 8: Finite Difference Expressions & Error Part II (Theory) February 7, 2015 22.520 Numerical Methods for PDEs : Video 8: Finite Difference February Expressions

More information

Fractional PDE Approach for Numerical Solution of Some Jump-Diffusion Models

Fractional PDE Approach for Numerical Solution of Some Jump-Diffusion Models Fractional PDE Approach for Numerical Solution of Some Jump-Diffusion Models Andrey Itkin 1 1 HAP Capital and Rutgers University, New Jersey Math Finance and PDE Conference, New Brunswick 2009 A.Itkin

More information

d n U i dx n dx n δ n U i

d n U i dx n dx n δ n U i Last time Taylor s series on equally spaced nodes Forward difference d n U i d n n U i h n + 0 h Backward difference d n U i d n n U i h n + 0 h Centered difference d n U i d n δ n U i or 2 h n + 0 h2

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

Lec 1: Single Agent Dynamic Models: Nested Fixed Point Approach. K. Sudhir MGT 756: Empirical Methods in Marketing

Lec 1: Single Agent Dynamic Models: Nested Fixed Point Approach. K. Sudhir MGT 756: Empirical Methods in Marketing Lec 1: Single Agent Dynamic Models: Nested Fixed Point Approach K. Sudhir MGT 756: Empirical Methods in Marketing RUST (1987) MODEL AND ESTIMATION APPROACH A Model of Harold Zurcher Rust (1987) Empirical

More information

Short-time-to-expiry expansion for a digital European put option under the CEV model. November 1, 2017

Short-time-to-expiry expansion for a digital European put option under the CEV model. November 1, 2017 Short-time-to-expiry expansion for a digital European put option under the CEV model November 1, 2017 Abstract In this paper I present a short-time-to-expiry asymptotic series expansion for a digital European

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

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

Continuous-Time Pension-Fund Modelling

Continuous-Time Pension-Fund Modelling . Continuous-Time Pension-Fund Modelling Andrew J.G. Cairns Department of Actuarial Mathematics and Statistics, Heriot-Watt University, Riccarton, Edinburgh, EH4 4AS, United Kingdom Abstract This paper

More information

Lesson 21: Comparing Linear and Exponential Functions Again

Lesson 21: Comparing Linear and Exponential Functions Again : Comparing Linear and Exponential Functions Again Student Outcomes Students create models and understand the differences between linear and exponential models that are represented in different ways. Lesson

More information

CONVERGENCE OF NUMERICAL METHODS FOR VALUING PATH-DEPENDENT OPTIONS USING INTERPOLATION

CONVERGENCE OF NUMERICAL METHODS FOR VALUING PATH-DEPENDENT OPTIONS USING INTERPOLATION CONVERGENCE OF NUMERICAL METHODS FOR VALUING PATH-DEPENDENT OPTIONS USING INTERPOLATION P.A. Forsyth Department of Computer Science University of Waterloo Waterloo, ON Canada N2L 3G1 E-mail: paforsyt@elora.math.uwaterloo.ca

More information

Stock loan valuation under a stochastic interest rate model

Stock loan valuation under a stochastic interest rate model University of Wollongong Research Online University of Wollongong Thesis Collection 1954-2016 University of Wollongong Thesis Collections 2015 Stock loan valuation under a stochastic interest rate model

More information

Advanced Numerical Techniques for Financial Engineering

Advanced Numerical Techniques for Financial Engineering Advanced Numerical Techniques for Financial Engineering Andreas Binder, Heinz W. Engl, Andrea Schatz Abstract We present some aspects of advanced numerical analysis for the pricing and risk managment of

More information

13.3 A Stochastic Production Planning Model

13.3 A Stochastic Production Planning Model 13.3. A Stochastic Production Planning Model 347 From (13.9), we can formally write (dx t ) = f (dt) + G (dz t ) + fgdz t dt, (13.3) dx t dt = f(dt) + Gdz t dt. (13.33) The exact meaning of these expressions

More information

Fractional Black - Scholes Equation

Fractional Black - Scholes Equation Chapter 6 Fractional Black - Scholes Equation 6.1 Introduction The pricing of options is a central problem in quantitative finance. It is both a theoretical and practical problem since the use of options

More information

202: Dynamic Macroeconomics

202: Dynamic Macroeconomics 202: Dynamic Macroeconomics Solow Model Mausumi Das Delhi School of Economics January 14-15, 2015 Das (Delhi School of Economics) Dynamic Macro January 14-15, 2015 1 / 28 Economic Growth In this course

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

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

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

No ANALYTIC AMERICAN OPTION PRICING AND APPLICATIONS. By A. Sbuelz. July 2003 ISSN

No ANALYTIC AMERICAN OPTION PRICING AND APPLICATIONS. By A. Sbuelz. July 2003 ISSN No. 23 64 ANALYTIC AMERICAN OPTION PRICING AND APPLICATIONS By A. Sbuelz July 23 ISSN 924-781 Analytic American Option Pricing and Applications Alessandro Sbuelz First Version: June 3, 23 This Version:

More information

Notes on Estimating the Closed Form of the Hybrid New Phillips Curve

Notes on Estimating the Closed Form of the Hybrid New Phillips Curve Notes on Estimating the Closed Form of the Hybrid New Phillips Curve Jordi Galí, Mark Gertler and J. David López-Salido Preliminary draft, June 2001 Abstract Galí and Gertler (1999) developed a hybrid

More information

Optimizing Modular Expansions in an Industrial Setting Using Real Options

Optimizing Modular Expansions in an Industrial Setting Using Real Options Optimizing Modular Expansions in an Industrial Setting Using Real Options Abstract Matt Davison Yuri Lawryshyn Biyun Zhang The optimization of a modular expansion strategy, while extremely relevant in

More information

Weak Reflection Principle and Static Hedging of Barrier Options

Weak Reflection Principle and Static Hedging of Barrier Options Weak Reflection Principle and Static Hedging of Barrier Options Sergey Nadtochiy Department of Mathematics University of Michigan Apr 2013 Fields Quantitative Finance Seminar Fields Institute, Toronto

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

Calibration Lecture 4: LSV and Model Uncertainty

Calibration Lecture 4: LSV and Model Uncertainty Calibration Lecture 4: LSV and Model Uncertainty March 2017 Recap: Heston model Recall the Heston stochastic volatility model ds t = rs t dt + Y t S t dw 1 t, dy t = κ(θ Y t ) dt + ξ Y t dw 2 t, where

More information

No-arbitrage theorem for multi-factor uncertain stock model with floating interest rate

No-arbitrage theorem for multi-factor uncertain stock model with floating interest rate Fuzzy Optim Decis Making 217 16:221 234 DOI 117/s17-16-9246-8 No-arbitrage theorem for multi-factor uncertain stock model with floating interest rate Xiaoyu Ji 1 Hua Ke 2 Published online: 17 May 216 Springer

More information

1 The Hull-White Interest Rate Model

1 The Hull-White Interest Rate Model Abstract Numerical Implementation of Hull-White Interest Rate Model: Hull-White Tree vs Finite Differences Artur Sepp Mail: artursepp@hotmail.com, Web: www.hot.ee/seppar 30 April 2002 We implement the

More information

Homework 1 posted, due Friday, September 30, 2 PM. Independence of random variables: We say that a collection of random variables

Homework 1 posted, due Friday, September 30, 2 PM. Independence of random variables: We say that a collection of random variables Generating Functions Tuesday, September 20, 2011 2:00 PM Homework 1 posted, due Friday, September 30, 2 PM. Independence of random variables: We say that a collection of random variables Is independent

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

An Efficient Numerical Scheme for Simulation of Mean-reverting Square-root Diffusions

An Efficient Numerical Scheme for Simulation of Mean-reverting Square-root Diffusions Journal of Numerical Mathematics and Stochastics,1 (1) : 45-55, 2009 http://www.jnmas.org/jnmas1-5.pdf JNM@S Euclidean Press, LLC Online: ISSN 2151-2302 An Efficient Numerical Scheme for Simulation of

More information

A CONTROL PERSPECTIVE TO ADAPTIVE TIME STEPPING IN RESERVOIR SIMULATION. A Thesis DANY ELOM AKAKPO

A CONTROL PERSPECTIVE TO ADAPTIVE TIME STEPPING IN RESERVOIR SIMULATION. A Thesis DANY ELOM AKAKPO A CONTROL PERSPECTIVE TO ADAPTIVE TIME STEPPING IN RESERVOIR SIMULATION A Thesis by DANY ELOM AKAKPO Submitted to the Office of Graduate and Professional Studies of Texas A&M University in partial fulfillment

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

The Yield Envelope: Price Ranges for Fixed Income Products

The Yield Envelope: Price Ranges for Fixed Income Products The Yield Envelope: Price Ranges for Fixed Income Products by David Epstein (LINK:www.maths.ox.ac.uk/users/epstein) Mathematical Institute (LINK:www.maths.ox.ac.uk) Oxford Paul Wilmott (LINK:www.oxfordfinancial.co.uk/pw)

More information

The mathematical finance of Quants and backward stochastic differential equations

The mathematical finance of Quants and backward stochastic differential equations The mathematical finance of Quants and backward stochastic differential equations Arnaud LIONNET INRIA (Mathrisk) INRIA-PRO Junior Seminar 17th February 2015 Financial derivatives Derivative contract :

More information

Option Pricing Formula for Fuzzy Financial Market

Option Pricing Formula for Fuzzy Financial Market Journal of Uncertain Systems Vol.2, No., pp.7-2, 28 Online at: www.jus.org.uk Option Pricing Formula for Fuzzy Financial Market Zhongfeng Qin, Xiang Li Department of Mathematical Sciences Tsinghua University,

More information

Continuous-time Stochastic Control and Optimization with Financial Applications

Continuous-time Stochastic Control and Optimization with Financial Applications Huyen Pham Continuous-time Stochastic Control and Optimization with Financial Applications 4y Springer Some elements of stochastic analysis 1 1.1 Stochastic processes 1 1.1.1 Filtration and processes 1

More information

Comparative Study between Linear and Graphical Methods in Solving Optimization Problems

Comparative Study between Linear and Graphical Methods in Solving Optimization Problems Comparative Study between Linear and Graphical Methods in Solving Optimization Problems Mona M Abd El-Kareem Abstract The main target of this paper is to establish a comparative study between the performance

More information

in Stochastic Interest Rate Models

in Stochastic Interest Rate Models ACTUARIAL RESEARCH CLEARING HOUSE 1997 VOL. 1 Estimating Long-term Returns in Stochastic Interest Rate Models Lijia Guo *and Zeng Huang Abstract This paper addresses the evaluation of long-term returns

More information

Applied Stochastic Processes and Control for Jump-Diffusions

Applied Stochastic Processes and Control for Jump-Diffusions Applied Stochastic Processes and Control for Jump-Diffusions Modeling, Analysis, and Computation Floyd B. Hanson University of Illinois at Chicago Chicago, Illinois siam.. Society for Industrial and Applied

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

004: Macroeconomic Theory

004: Macroeconomic Theory 004: Macroeconomic Theory Lecture 14 Mausumi Das Lecture Notes, DSE October 21, 2014 Das (Lecture Notes, DSE) Macro October 21, 2014 1 / 20 Theories of Economic Growth We now move on to a different dynamics

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

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