Darae Jeong, Junseok Kim, and In-Suk Wee

Size: px
Start display at page:

Download "Darae Jeong, Junseok Kim, and In-Suk Wee"

Transcription

1 Commun. Korean Math. Soc. 4 (009), No. 4, pp DOI /CKMS AN ACCURATE AND EFFICIENT NUMERICAL METHOD FOR BLACK-SCHOLES EQUATIONS Darae Jeong, Junseo Kim, and In-Su Wee Abstract. We present an efficient and accurate finite-difference method for computing Blac-Scholes partial differential equations with multiunderlying assets. We directly solve Blac-Scholes equations without transformations of variables. We provide computational results showing the performance of the method for two underlying asset option pricing problems. 1. Introduction Blac and Scholes [1], and Merton [10] derived a parabolic second order partial differential equation (PDE) for the value u(s, t) of an option on stocs. We propose a finite difference method to solve the generalized multi-asset Blac- Scholes PDE. Let s i, i = 1,,..., n denote the price of the underlying i-th asset and u(s 1, s,..., s n, t) denote the value of the option. The prices s i of the underlying assets are described by geometric Brownian motions ds i = µ i s i dt + σ i s i dw i, i = 1,,..., n, where µ i and σ i denote a constant expected rate of return and a constant volatility of the i-th asset, respectively. Here, W i is the standard Brownian motion. Let ρ ij denote the correlation coefficient between two Brownian motions W i and W j where dw i dw j = ρ ij dt, i, j = 1,,..., n, i j. Received December 14, Mathematics Subject Classification. Primary 65N06, 65M55. Key words and phrases. Blac-Scholes equations, finite difference method, multigrid method. This wor was supported by the research fund (R060084) of Seoul Research and Business Development Program. 617 c 009 The Korean Mathematical Society

2 618 DARAE JEONG, JUNSEOK KIM, AND IN-SUK WEE Then, the no arbitrage principle leads to the following generalized n-asset Blac-Scholes equation [7, 9, 0]: (1) u(s, t) t + 1 n i,j=1 σ i σ j ρ ij s i s j u(s, t) s i s j + r n i=1 for (s, t) = (s 1, s,..., s n, t) R n + [0, T ), s i u(s, t) s i = ru(s, t) where r > 0 is a constant risless interest rate. The final condition is the payoff function u T (s) at expiry T () u(s, T ) = u T (s). The analytic solutions of Eqs. (1) and () for exotic options are very limited. Therefore, we need to rely on a numerical approximation. To obtain an approximation of the option value, we can compute a solution of Blac-Scholes PDEs (1) and () using a finite difference method (FDM) [3, 15, 16, 17, 0]. We apply the FDM to the equation over a truncated finite domain. The original asymptotic infinite boundary conditions are shifted to the ends of the truncated finite domain. To avoid generating large errors in the solution due to this approximation of the boundary conditions, the truncated domain must be large enough resulting in large computational costs. The purpose of our wor is to propose an efficient and accurate FDM to directly solve the Blac-Scholes PDEs (1) and () without transformations of variables. The outline of this paper is the following. In Section we formulate the Blac-Scholes (BS) partial differential equation with two underlying assets. In Section 3, we focus on the details of a multigrid solver for the BS equation. In Section 4, we present the results of numerical experiments. We draw conclusions in Section 5.. The Blac-Scholes model We use a Blac-Scholes model with two underlying assets to eep this presentation simple. However, we can easily extend the current method for more than two underlying assets. Let us consider the computational domain Ω = (0, L) (0, M) for the two assets case. Let x = s 1 and y = s. Then from the change of variable τ = T t, we obtain an initial value problem: (3) u τ = 1 (σ 1x) u x + 1 (σ y) u y + σ 1σ ρxy u x y +rx u u + ry ru for (x, y, τ) Ω (0, T ], x y with an initial condition u(x, y, 0) = u T (x, y) for (x, y) Ω. There are several possible boundary conditions such as Neumann [3, 5], Dirichlet, linear, and PDE [3, 16] that can be used for these inds of problems. In this wor, we use

3 AN ACCURATE AND EFFICIENT NUMERICAL METHOD FOR BS EQUATIONS 619 a linear boundary condition on all boundaries, i.e., u x (0, y, τ) = u x (L, y, τ) = u y (x, 0, τ) = u (x, M, τ) = 0, y τ [0, T ] for 0 x L, 0 y M. 3. A numerical solution 3.1. Discretization with finite differences A finite difference method is a common numerical method that has been used by many researchers in computational finance. For an introduction to these methods we recommend the boos [3, 15, 16, 17, 0]. They all introduce the concept of finite differences for option pricing and provide basic nowledge needed for a simple implementation of the method. An approach for the Blac- Scholes option problem is to use an efficient solver such as the Bi-CGSTAB (Biconjugate gradient stabilized) method [1, 14, 19], GMRES (Generalized minimal residual algorithm) method [11, 13], ADI (Alternating direction implicit) method [, 3], and the OS (Operator splitting) method [3, 8]. Let us first discretize the given computational domain Ω = (0, L) (0, M) as a uniform grid with a space step h = L/N x = M/N y and a time step t = T/N t. Let us denote the numerical approximation of the solution by u n ij u(x i, y j, t n ) = u ((i 0.5)h, (j 0.5)h, n t), where i = 1,..., N x and j = 1,..., N y. We use a cell centered discretization since we use a linear boundary condition. By applying the implicit time scheme and centered difference for space derivatives to Eq. (3), we have (4) ij u n ij t = L BS ij, where the discrete difference operator L BS is defined by L BS ij = (σ 1x i ) + (σ y j ) 3.. A multigrid method i 1,j un+1 ij + h i+1,j i,j 1 un+1 ij + i,j+1 h +σ 1 σ ρx i y j i+1,j+1 + un+1 i 1,j 1 un+1 i 1,j+1 un+1 i+1,j 1 4h i+1,j +rx un+1 i 1,j i + ry j h i,j+1 un+1 i,j 1 h r ij. Multigrid methods belong to the class of fastest iterations, because their convergence rate is independent of the space step size [4]. In order to explain

4 60 DARAE JEONG, JUNSEOK KIM, AND IN-SUK WEE (a) Ω 3 (16 16) h (b) Ω (8 8) h (c) Ω 1 (4 4) 4h (d) Ω 0 ( ) 8h (e) Figure 1. (a), (b), (c), and (d) are a sequence of coarse grids starting with h = L/N x. (e) is a composition of grids, Ω 3, Ω, Ω 1, and Ω 0. clearly the steps taen during a single V-cycle, we focus on a numerical solution on a mesh. We define discrete domains, Ω 3, Ω, Ω 1, and Ω 0, where Ω = {(x,i = (i 0.5)h, y,j = (j 0.5)h ) 1 i, j +1 and h = 3 h}. Ω 1 is coarser than Ω by a factor of. The multigrid solution of the discrete BS Eq. (4) maes use of a hierarchy of meshes (Ω 3, Ω, Ω 1, and Ω 0 ) created by successively coarsening the original mesh, Ω 3 as shown in Fig. 1. A pointwise Gauss-Seidel relaxation scheme is used as the smoother in the multigrid method. We use a notation u n as a numerical solution on the discrete domain Ω at time t = n t. The algorithm of the multigrid method for solving the discrete BS Eq. (4) is as follows. We rewrite the above Eq. (4) by (5) where L 3 ( 3,ij ) = φn 3,ij on Ω 3, L 3 ( 3,ij ) = un+1 3,ij tl BS 3 3,ij and φn 3,ij = u n 3,ij. Given the numbers, ν 1 and ν, of pre- and post- smoothing relaxation sweeps, an iteration step for the multigrid method using the V-cycle is formally written as follows [18]. That is, starting an initial condition u 0 3, we want to find u n 3 for n = 1,,.... Given u n 3, we want to find the 3 solution that satisfies Eq. (4). At the very beginning of the multigrid cycle the solution from the previous time step is used to provide an initial guess for the multigrid procedure. First, let,0 3 = u n 3.

5 AN ACCURATE AND EFFICIENT NUMERICAL METHOD FOR BS EQUATIONS 61 Multigrid cycle,m+1 = MGcycle(,,m, L, φ n, ν 1, ν ). That is,,m and,m+1 are the approximations of before and after an MGcycle. Now, define the MGcycle. Step 1) Presmoothing,ij = ū n+1,m φ n,ij + t = SMOOT H ν1 (,m, L, φ n ), means performing ν 1 smoothing steps with the initial approximation,m, source terms φ n, and a SMOOT H relaxation operator to get the approximation ū n+1,m. Here, we derive the smoothing operator in two dimensions. Now we derive a Gauss-Seidel relaxation operator. First, we rewrite Eq. (5) as [ ( (σ 1 x,i ) (6) + (σ y,j ),i,j 1 + un+1,i,j+1 h,i 1,j + un+1,i+1,j h +σ 1 σ ρx,i y,j,i+1,j+1 + un+1,i 1,j 1 un+1,i 1,j+1 un+1,i+1,j 1 + rx,i,i+1,j un+1,i 1,j [ 1 + t h 4h + ry,j h ( (σ1 x,i ) + (σ y,j ) )] + r.,i,j+1 un+1,i,j 1 h )] / Next, we replace,αβ in Eq. (6) with ūn+1,m,αβ if (α < i) or (α = i and β j), otherwise with,m,αβ, i.e., ū n+1,m,ij = (7) [ φ n,ij + t + (σ y,j ) ( (σ 1 x,i ) ū n+1,m,i,j 1 + un+1,m,i,j+1 h ū n+1,m,i 1,j + un+1,m,i+1,j h +σ 1 σ ρx,i y,j,m,i+1,j+1 + ūn+1,m,i 1,j 1 ūn+1,m,i 1,j+1 un+1,m,i+1,j 1,m,i+1,j + rx ūn+1,m,i 1,j,i h [ 1 + t ( (σ1 x,i ) + (σ y,j ) h 4h,m i,j+1 + ry,j )] + r. ū n+1,m,i,j 1 h )] /

6 6 DARAE JEONG, JUNSEOK KIM, AND IN-SUK WEE Therefore, in a multigrid cycle, one smooth relaxation operator step consists of solving Eq. (7) given above for 1 i 3 N x and 1 j 3 N y. Step ) Coarse grid correction Compute the defect: dm = φ n L (ū n+1,m ). Restrict the defect and ū m : dm 1 = I 1 d m The restriction operator I 1 maps -level functions to ( 1)-level functions as shown in Fig. (a). d 1 (x i, y j ) = I 1 d (x i, y j ) = 1 4 [d (x i 1, y j 1 ) + d (x i 1, y j+ 1 ) +d (x i+ 1, y j 1 ) + d (x i+ 1, y j+ 1 )]. (a) (b) Figure. Transfer operators : (a) restriction and (b) interpolation. Compute an approximate solution û n+1,m 1 of the coarse grid equation on Ω 1, i.e., (8) L 1 (,m 1 ) = d m 1. If = 1, we use a direct or fast iteration solver for (8). If > 1, we solve (8) approximately by performing -grid cycles using the zero grid function as an initial approximation: ˆv n+1,m 1 = MGcycle( 1, 0, L 1, d m 1, ν 1, ν ). Interpolate the correction: ˆv n+1,m = I 1ˆvn+1,m. Here, the coarse values are simply transferred to the four nearby fine grid points as shown in Fig. (b), i.e., v (x i, y j ) = I 1 v 1(x i, y j ) = v 1 (x i+ 1, y j+ 1 ) for the i and j oddnumbered integers. Compute the corrected approximation on Ω Step 3) Postsmoothing:,m+1 m, u after CGC = ū n+1,m + ˆv n+1,m. = SMOOT H ν (u m, after CGC, L, φ n ).

7 AN ACCURATE AND EFFICIENT NUMERICAL METHOD FOR BS EQUATIONS 63 This completes the description of a MGcycle. An illustration of the corresponding two-grid cycle is given in Fig. 3. For the multi-grid V-cycle, it is given in Fig. 4.,m smooth ν1 ū n+1,m,m+1 smooth ν d m = φ n L (ū n+1,m ) u m,aftercgc = ū n+1,m + ˆv n+1,m Restrict(I 1 ) d m 1 = I 1 d m ˆv n+1,m Interpolate(I 1 ) = I 1ˆvn+1,m 1 Solve L 1 (ˆv n+1,m 1 ) d m 1 Figure 3. The MG (, 1) two-grid method. 4. Computational results In this section, we perform a convergence test of the scheme and present several numerical experiments. Two-asset cash or nothing options can be useful building blocs for constructing more complex exotic option products. Let us consider a two-asset cash or nothing call option. This option pays out a fixed cash amount K if asset one, x, is above the strie X 1 and asset two, y, is above strie X at expiration. The payoff is given by { K if x X1 and y X u(x, y, 0) =, (9) 0 otherwise. (10) The formula for the exact value is nown in [6] by where u(x, y, T ) = Ke rt M(α, β; ρ), α = ln(x/k 1)+(r σ 1 /)T σ 1 T, β = ln(y/k )+(r σ /)T σ T.

8 64 DARAE JEONG, JUNSEOK KIM, AND IN-SUK WEE Ω 3, h Ω, h Ω 1, 4h Ω 0, 8h Figure 4. Schedule of grids for V-cycle. Here M(α, β; ρ) denotes a standardized cumulative normal function where one random variable is less than α and a second random variable is less than β. The correlation between the two variables is ρ: 1 α β M(α, β; ρ) = π exp [ x ρxy + y ] 1 ρ (1 ρ dxdy. ) The MATLAB code for the closed form solution of a two-asset cash or nothing call option is given in Appendix A Convergence test To obtain an estimate of the rate of convergence, we performed a number of simulations for a sample initial problem on a set of increasingly finer grids. We considered a domain, Ω = [0, 300] [0, 300]. We computed the numerical solutions on uniform grids, h = 300/ n for n = 5, 6, 7, and 8. For each case, we ran the calculation to time T = 0.1 with a uniform time step depending on

9 AN ACCURATE AND EFFICIENT NUMERICAL METHOD FOR BS EQUATIONS 65 a mesh size, t = 0.03/ n. The initial condition is Eq. (9) with K = 1 and X 1 = X = 100. The volatilities are σ 1 = 0.5 and σ = 0.5. The correlation is ρ = 0.5, and the risless interest rate is r = Figs. 5 (a) and (b) show the initial configuration and final profile at T, respectively. 1 1 u u x (a) y x (b) 100 y Figure 5. (a) The initial condition and (b) numerical result at T = 0.1. We let e be the error matrix with components e ij = u(x i, y j ) u ij. u(x i, y j ) is the analytic solution of Eq. (10) and u ij is the numerical solution. We compute its discrete L norm e is defined e = 1 N x N y e ij N x N. y i=1 j=1 The errors and rates of convergence are given in Table 1. The results show that the scheme is first-order accurate. Table 1. The L norms of errors and convergence rates for u at time T = 0.1. Case 3 3 rate rate rate e Multigrid performance We investigated the convergence behavior of our MG method, especially mesh independence. The test problem was that of a two-asset cash or nothing call option with the convergence test parameter set. The average number of iterations per time step (see Fig. 6) and the CPU-time in seconds required for a solution to an identical convergence tolerance are displayed in Table.

10 66 DARAE JEONG, JUNSEOK KIM, AND IN-SUK WEE Although the number of multigrid iterations for convergence at each time step slowly increased as the mesh was refined, from a practical viewpoint, it was essentially grid independent vcycle number iteration number Figure 6. Number of V-cycles. 5. Conclusions In this paper, we focused on the performance of a multigrid method for option pricing problems. The numerical results showed that the total computational cost was proportional to the number of grid points. The convergence test showed that the scheme was first-order accurate since we used an implicit Euler method. In a forthcoming paper, we will investigate a switching grid method, which uses a fine mesh when the solution is not smooth and otherwise uses a coarse mesh. Appendix A. MATLAB code for a closed form solution L=300; K=1; T=0.1; r=0.03; sigma1=0.5; sigma=0.5; rho=0.5; Table. Grid independence with an iteration convergence tolerance of 10 5, T = 0.1 and t = Mesh Average iterations per time step CPU(s)

11 AN ACCURATE AND EFFICIENT NUMERICAL METHOD FOR BS EQUATIONS 67 N=64; h=l/n; S=linspace(h/,L-h/,N); VE=zeros(N,N); mu=[0 0]; for i=1:n for j=1:n y1 = (log(s(i)/k)+(b1-sigma1^/)*t)/(sigma1*sqrt(t)); y = (log(s(j)/k)+(b-sigma^/)*t)/(sigma*sqrt(t)); X = [y1 y]; cov = [1 rho; rho 1]; M = mvncdf(x,mu,cov); V(i,j) = K*exp(-r*T)*M; end end [X, Y] = meshgrid(s); surf(x, Y, V) References [1] F. Blac and M. Sholes, The pricing of options and corporate liabilities, J. Political Economy 81 (1973), no. 3, [] R. C. Y. Chin, T. A. Manteuffel, and J. de Pillis, ADI as a preconditioning for solving the convection-diffusion equation, SIAM J. Sci. Stat. Comput. 5 (1984), no., [3] D. J. Duffy, Finite Difference Methods in Financial Engineering : a partial differential equation approach, John Wiley and Sons, New Yor, 006. [4] W. Hacbusch, Iterative Solution of Large Linear Systems of Equations, Springer, New Yor, [5] H. Han and X. Wu, A fast numerical method for the Blac-Scholes equation of American options, SIAM J. Numer. Anal. 41 (003), [6] E. G. Haug, The Complete Guide to Option Pricing Formulas, MaGraw-Hill, 007. [7] J. C. Hull, Options, Futures and Others, Prentice Hall, 003. [8] S. Ionen and J. Toivanen, Operator splitting methods for American option pricing, Applied Mathematics Letters 17 (004), [9] Y. K. Kwo, Mathematical Models of Financial Derivatives, Springer, [10] R. C. Merton, Theory of rational option pricing, Bell J. Econ. Manag. Sci. 4 (1973), no. 1, [11] J. Persson and L. von Sydow, Pricing European multi-asset options using a space-time adaptive FD-method, Comput. Visual. Sci. 10 (007), [1] C. Reisinger and G. Wittum, On multigrid for anisotropic equations and variational inequalities, Comput. Visual. Sci. 7 (004), [13] Y. Saad and M. Schultz, GMRES: A generalized minimal residual algorithm for solving nonsymmetric linear systems, SIAM J. Sci. Stat. Comput. 7 (1986), [14] Y. Saad and H. A. van der Vorst, Iterative solution of linear systems in the 0th century, J. Comput. Appl. Math. 13 (000), [15] R. Seydel, Tools for Computational Finance, Springer Verlag, Berlin, 003. [16] D. Tavella and C. Randall, Pricing Financial Instruments - The finite difference method, John Wiley and Sons, Inc., 000. [17] J. Topper, Financial Engineering with Finite Elements, John Wiley and Sons, New Yor, 005. [18] U. Trottenberg, C. Oosterlee, and A. Schüller, Multigrid, Academic press, 001.

12 68 DARAE JEONG, JUNSEOK KIM, AND IN-SUK WEE [19] H. A. Van Der Vorst, BI-CGSTAB: A fast and smoothly converging variant of BI-CG for the solution of nonsymmetric linear systems, SIAM J. Sci. Stat. Comput. 13 (199), no., [0] P. Wilmott, J. Dewynne, and S. Howison, Option Pricing : mathematical models and computation, Oxford Financia Press, Oxford, Darae Jeong Department of Mathematics Korea University Seoul , Korea address: tinayoyo@orea.ac.r Junseo Kim Department of Mathematics Korea University Seoul , Korea address: cfdim@orea.ac.r In-Su Wee Department of Mathematics Korea University Seoul , Korea address: iswee@orea.ac.r

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

EFFICIENT MONTE CARLO ALGORITHM FOR PRICING BARRIER OPTIONS

EFFICIENT MONTE CARLO ALGORITHM FOR PRICING BARRIER OPTIONS Commun. Korean Math. Soc. 23 (2008), No. 2, pp. 285 294 EFFICIENT MONTE CARLO ALGORITHM FOR PRICING BARRIER OPTIONS Kyoung-Sook Moon Reprinted from the Communications of the Korean Mathematical Society

More information

AN ADAPTIVE MULTIGRID TECHNIQUE FOR OPTION PRICING UNDER THE BLACK SCHOLES MODEL

AN ADAPTIVE MULTIGRID TECHNIQUE FOR OPTION PRICING UNDER THE BLACK SCHOLES MODEL J. KSIAM Vol.17, No.4, 295 36, 213 http://dx.doi.org/1.12941/jsiam.213.17.295 AN ADAPTIVE MULTIGRID TECHNIQUE FOR OPTION PRICING UNDER THE BLACK SCHOLES MODEL DARAE JEONG 1, YIBAO LI 1, YONGHO CHOI 1,

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

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

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

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

Assignment - Exotic options

Assignment - Exotic options Computational Finance, Fall 2014 1 (6) Institutionen för informationsteknologi Besöksadress: MIC, Polacksbacken Lägerhyddvägen 2 Postadress: Box 337 751 05 Uppsala Telefon: 018 471 0000 (växel) Telefax:

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

Chapter 3: Black-Scholes Equation and Its Numerical Evaluation

Chapter 3: Black-Scholes Equation and Its Numerical Evaluation Chapter 3: Black-Scholes Equation and Its Numerical Evaluation 3.1 Itô Integral 3.1.1 Convergence in the Mean and Stieltjes Integral Definition 3.1 (Convergence in the Mean) A sequence {X n } n ln of random

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

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

Finite Difference Approximation of Hedging Quantities in the Heston model

Finite Difference Approximation of Hedging Quantities in the Heston model Finite Difference Approximation of Hedging Quantities in the Heston model Karel in t Hout Department of Mathematics and Computer cience, University of Antwerp, Middelheimlaan, 22 Antwerp, Belgium Abstract.

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

AN IMPROVED BINOMIAL METHOD FOR PRICING ASIAN OPTIONS

AN IMPROVED BINOMIAL METHOD FOR PRICING ASIAN OPTIONS Commun. Korean Math. Soc. 28 (2013), No. 2, pp. 397 406 http://dx.doi.org/10.4134/ckms.2013.28.2.397 AN IMPROVED BINOMIAL METHOD FOR PRICING ASIAN OPTIONS Kyoung-Sook Moon and Hongjoong Kim Abstract. We

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

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

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

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

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

Heston Model Version 1.0.9

Heston Model Version 1.0.9 Heston Model Version 1.0.9 1 Introduction This plug-in implements the Heston model. Once installed the plug-in offers the possibility of using two new processes, the Heston process and the Heston time

More information

A NEW NOTION OF TRANSITIVE RELATIVE RETURN RATE AND ITS APPLICATIONS USING STOCHASTIC DIFFERENTIAL EQUATIONS. Burhaneddin İZGİ

A NEW NOTION OF TRANSITIVE RELATIVE RETURN RATE AND ITS APPLICATIONS USING STOCHASTIC DIFFERENTIAL EQUATIONS. Burhaneddin İZGİ A NEW NOTION OF TRANSITIVE RELATIVE RETURN RATE AND ITS APPLICATIONS USING STOCHASTIC DIFFERENTIAL EQUATIONS Burhaneddin İZGİ Department of Mathematics, Istanbul Technical University, Istanbul, Turkey

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

Option Valuation with Sinusoidal Heteroskedasticity

Option Valuation with Sinusoidal Heteroskedasticity Option Valuation with Sinusoidal Heteroskedasticity Caleb Magruder June 26, 2009 1 Black-Scholes-Merton Option Pricing Ito drift-diffusion process (1) can be used to derive the Black Scholes formula (2).

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

The Forward Kolmogorov Equation for Two Dimensional Options

The Forward Kolmogorov Equation for Two Dimensional Options The Forward Kolmogorov Equation for Two Dimensional Options Antoine Conze (Nexgenfs bank), Nicolas Lantos (Nexgenfs bank and UPMC), Olivier Pironneau (LJLL, University of Paris VI) March, 04 Abstract Pricing

More information

FROM NAVIER-STOKES TO BLACK-SCHOLES: NUMERICAL METHODS IN COMPUTATIONAL FINANCE

FROM NAVIER-STOKES TO BLACK-SCHOLES: NUMERICAL METHODS IN COMPUTATIONAL FINANCE Irish Math. Soc. Bulletin Number 75, Summer 2015, 7 19 ISSN 0791-5578 FROM NAVIER-STOKES TO BLACK-SCHOLES: NUMERICAL METHODS IN COMPUTATIONAL FINANCE DANIEL J. DUFFY Abstract. In this article we give a

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

4. Black-Scholes Models and PDEs. Math6911 S08, HM Zhu

4. Black-Scholes Models and PDEs. Math6911 S08, HM Zhu 4. Black-Scholes Models and PDEs Math6911 S08, HM Zhu References 1. Chapter 13, J. Hull. Section.6, P. Brandimarte Outline Derivation of Black-Scholes equation Black-Scholes models for options Implied

More information

ADAPTIVE PARTIAL DIFFERENTIAL EQUATION METHODS FOR OPTION PRICING

ADAPTIVE PARTIAL DIFFERENTIAL EQUATION METHODS FOR OPTION PRICING ADAPTIVE PARTIAL DIFFERENTIAL EQUATION METHODS FOR OPTION PRICING by Guanghuan Hou B.Sc., Zhejiang University, 2004 a project submitted in partial fulfillment of the requirements for the degree of Master

More information

THE USE OF NUMERAIRES IN MULTI-DIMENSIONAL BLACK- SCHOLES PARTIAL DIFFERENTIAL EQUATIONS. Hyong-chol O *, Yong-hwa Ro **, Ning Wan*** 1.

THE USE OF NUMERAIRES IN MULTI-DIMENSIONAL BLACK- SCHOLES PARTIAL DIFFERENTIAL EQUATIONS. Hyong-chol O *, Yong-hwa Ro **, Ning Wan*** 1. THE USE OF NUMERAIRES IN MULTI-DIMENSIONAL BLACK- SCHOLES PARTIAL DIFFERENTIAL EQUATIONS Hyong-chol O *, Yong-hwa Ro **, Ning Wan*** Abstract The change of numeraire gives very important computational

More information

Heinz W. Engl. Industrial Mathematics Institute Johannes Kepler Universität Linz, Austria

Heinz W. Engl. Industrial Mathematics Institute Johannes Kepler Universität Linz, Austria Some Identification Problems in Finance Heinz W. Engl Industrial Mathematics Institute Johannes Kepler Universität Linz, Austria www.indmath.uni-linz.ac.at Johann Radon Institute for Computational and

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

Multi-Asset Options. A Numerical Study VILHELM NIKLASSON FRIDA TIVEDAL. Master s thesis in Engineering Mathematics and Computational Science

Multi-Asset Options. A Numerical Study VILHELM NIKLASSON FRIDA TIVEDAL. Master s thesis in Engineering Mathematics and Computational Science Multi-Asset Options A Numerical Study Master s thesis in Engineering Mathematics and Computational Science VILHELM NIKLASSON FRIDA TIVEDAL Department of Mathematical Sciences Chalmers University of Technology

More information

Postprint.

Postprint. http://www.diva-portal.org Postprint This is the accepted version of a paper published in International Journal of Computer Mathematics. This paper has been peer-reviewed but does not include the final

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

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

The Numerical Valuation of Options with Underlying Jumps

The Numerical Valuation of Options with Underlying Jumps The Numerical Valuation of Options with Underlying Jumps Gunter H. Meyer School of Mathematics Georgia Institute of Technology Atlanta, GA, 30332-060, U.S.A. Abstract A Black-Scholes type model for American

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

AMH4 - ADVANCED OPTION PRICING. Contents

AMH4 - ADVANCED OPTION PRICING. Contents AMH4 - ADVANCED OPTION PRICING ANDREW TULLOCH Contents 1. Theory of Option Pricing 2 2. Black-Scholes PDE Method 4 3. Martingale method 4 4. Monte Carlo methods 5 4.1. Method of antithetic variances 5

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

Journal of Mathematical Analysis and Applications

Journal of Mathematical Analysis and Applications J Math Anal Appl 389 (01 968 978 Contents lists available at SciVerse Scienceirect Journal of Mathematical Analysis and Applications wwwelseviercom/locate/jmaa Cross a barrier to reach barrier options

More information

A NOTE ON NUMERICAL SOLUTION OF A LINEAR BLACK-SCHOLES MODEL

A NOTE ON NUMERICAL SOLUTION OF A LINEAR BLACK-SCHOLES MODEL GANIT J. Bangladesh Math. Soc. (ISSN 1606-3694) Vol. 33 (2013) 103-115 A NOTE ON NUMERICAL SOLUTION OF A LINEAR BLACK-SCHOLES MODEL Md. Kazi Salah Uddin 1*, Mostak Ahmed 2 and Samir Kumar Bhowmik 1,3 1

More information

A No-Arbitrage Theorem for Uncertain Stock Model

A No-Arbitrage Theorem for Uncertain Stock Model Fuzzy Optim Decis Making manuscript No (will be inserted by the editor) A No-Arbitrage Theorem for Uncertain Stock Model Kai Yao Received: date / Accepted: date Abstract Stock model is used to describe

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

Using radial basis functions for option pricing

Using radial basis functions for option pricing Using radial basis functions for option pricing Elisabeth Larsson Division of Scientific Computing Department of Information Technology Uppsala University Actuarial Mathematics Workshop, March 19, 2013,

More information

Math 416/516: Stochastic Simulation

Math 416/516: Stochastic Simulation Math 416/516: Stochastic Simulation Haijun Li lih@math.wsu.edu Department of Mathematics Washington State University Week 13 Haijun Li Math 416/516: Stochastic Simulation Week 13 1 / 28 Outline 1 Simulation

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

Numerical algorithm for pricing of discrete barrier option in a Black-Scholes model

Numerical algorithm for pricing of discrete barrier option in a Black-Scholes model Int. J. Nonlinear Anal. Appl. 9 (18) No., 1-7 ISSN: 8-68 (electronic) http://dx.doi.org/1.75/ijnaa.17.415.16 Numerical algorithm for pricing of discrete barrier option in a Black-Scholes model Rahman Farnoosh

More information

Option Pricing Models for European Options

Option Pricing Models for European Options Chapter 2 Option Pricing Models for European Options 2.1 Continuous-time Model: Black-Scholes Model 2.1.1 Black-Scholes Assumptions We list the assumptions that we make for most of this notes. 1. The underlying

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

A High-order Front-tracking Finite Difference Method for Pricing American Options under Jump-Diffusion Models

A High-order Front-tracking Finite Difference Method for Pricing American Options under Jump-Diffusion Models A High-order Front-tracking Finite Difference Method for Pricing American Options under Jump-Diffusion Models Jari Toivanen Abstract A free boundary formulation is considered for the price of American

More information

TEST OF BOUNDED LOG-NORMAL PROCESS FOR OPTIONS PRICING

TEST OF BOUNDED LOG-NORMAL PROCESS FOR OPTIONS PRICING TEST OF BOUNDED LOG-NORMAL PROCESS FOR OPTIONS PRICING Semih Yön 1, Cafer Erhan Bozdağ 2 1,2 Department of Industrial Engineering, Istanbul Technical University, Macka Besiktas, 34367 Turkey Abstract.

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

HIGHER ORDER BINARY OPTIONS AND MULTIPLE-EXPIRY EXOTICS

HIGHER ORDER BINARY OPTIONS AND MULTIPLE-EXPIRY EXOTICS Electronic Journal of Mathematical Analysis and Applications Vol. (2) July 203, pp. 247-259. ISSN: 2090-792X (online) http://ejmaa.6te.net/ HIGHER ORDER BINARY OPTIONS AND MULTIPLE-EXPIRY EXOTICS HYONG-CHOL

More information

Valuation of performance-dependent options in a Black- Scholes framework

Valuation of performance-dependent options in a Black- Scholes framework Valuation of performance-dependent options in a Black- Scholes framework Thomas Gerstner, Markus Holtz Institut für Numerische Simulation, Universität Bonn, Germany Ralf Korn Fachbereich Mathematik, TU

More information

Computational Finance. Computational Finance p. 1

Computational Finance. Computational Finance p. 1 Computational Finance Computational Finance p. 1 Outline Binomial model: option pricing and optimal investment Monte Carlo techniques for pricing of options pricing of non-standard options improving accuracy

More information

A Moment Matching Approach To The Valuation Of A Volume Weighted Average Price Option

A Moment Matching Approach To The Valuation Of A Volume Weighted Average Price Option A Moment Matching Approach To The Valuation Of A Volume Weighted Average Price Option Antony Stace Department of Mathematics and MASCOS University of Queensland 15th October 2004 AUSTRALIAN RESEARCH COUNCIL

More information

The Black-Scholes Model

The Black-Scholes Model The Black-Scholes Model Liuren Wu Options Markets (Hull chapter: 12, 13, 14) Liuren Wu ( c ) The Black-Scholes Model colorhmoptions Markets 1 / 17 The Black-Scholes-Merton (BSM) model Black and Scholes

More information

Fast and accurate pricing of discretely monitored barrier options by numerical path integration

Fast and accurate pricing of discretely monitored barrier options by numerical path integration Comput Econ (27 3:143 151 DOI 1.17/s1614-7-991-5 Fast and accurate pricing of discretely monitored barrier options by numerical path integration Christian Skaug Arvid Naess Received: 23 December 25 / Accepted:

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

Analysis of pricing American options on the maximum (minimum) of two risk assets

Analysis of pricing American options on the maximum (minimum) of two risk assets Interfaces Free Boundaries 4, (00) 7 46 Analysis of pricing American options on the maximum (minimum) of two risk assets LISHANG JIANG Institute of Mathematics, Tongji University, People s Republic of

More information

Greek parameters of nonlinear Black-Scholes equation

Greek parameters of nonlinear Black-Scholes equation International Journal of Mathematics and Soft Computing Vol.5, No.2 (2015), 69-74. ISSN Print : 2249-3328 ISSN Online: 2319-5215 Greek parameters of nonlinear Black-Scholes equation Purity J. Kiptum 1,

More information

Risk Neutral Valuation

Risk Neutral Valuation copyright 2012 Christian Fries 1 / 51 Risk Neutral Valuation Christian Fries Version 2.2 http://www.christian-fries.de/finmath April 19-20, 2012 copyright 2012 Christian Fries 2 / 51 Outline Notation Differential

More information

OPTIMAL PORTFOLIO CONTROL WITH TRADING STRATEGIES OF FINITE

OPTIMAL PORTFOLIO CONTROL WITH TRADING STRATEGIES OF FINITE Proceedings of the 44th IEEE Conference on Decision and Control, and the European Control Conference 005 Seville, Spain, December 1-15, 005 WeA11.6 OPTIMAL PORTFOLIO CONTROL WITH TRADING STRATEGIES OF

More information

Numerical Solution of a Linear Black-Scholes Models: A Comparative Overview

Numerical Solution of a Linear Black-Scholes Models: A Comparative Overview IOSR Journal of Engineering (IOSRJEN) ISSN (e): 5-3, ISSN (p): 78-879 Vol. 5, Issue 8 (August. 5), V3 PP 45-5 www.iosrjen.org Numerical Solution of a Linear Black-Scholes Models: A Comparative Overview

More information

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid Solving the Stochastic Steady-State Diffusion Problem Using Multigrid Tengfei Su Applied Mathematics and Scientific Computing Program Advisor: Howard Elman Department of Computer Science May 5, 2016 Tengfei

More information

NEWCASTLE UNIVERSITY SCHOOL OF MATHEMATICS, STATISTICS & PHYSICS SEMESTER 1 SPECIMEN 2 MAS3904. Stochastic Financial Modelling. Time allowed: 2 hours

NEWCASTLE UNIVERSITY SCHOOL OF MATHEMATICS, STATISTICS & PHYSICS SEMESTER 1 SPECIMEN 2 MAS3904. Stochastic Financial Modelling. Time allowed: 2 hours NEWCASTLE UNIVERSITY SCHOOL OF MATHEMATICS, STATISTICS & PHYSICS SEMESTER 1 SPECIMEN 2 Stochastic Financial Modelling Time allowed: 2 hours Candidates should attempt all questions. Marks for each question

More information

Option Pricing Model with Stepped Payoff

Option Pricing Model with Stepped Payoff Applied Mathematical Sciences, Vol., 08, no., - 8 HIARI Ltd, www.m-hikari.com https://doi.org/0.988/ams.08.7346 Option Pricing Model with Stepped Payoff Hernán Garzón G. Department of Mathematics Universidad

More information

Option Approach to Risk-shifting Incentive Problem with Mutually Correlated Projects

Option Approach to Risk-shifting Incentive Problem with Mutually Correlated Projects Option Approach to Risk-shifting Incentive Problem with Mutually Correlated Projects Hiroshi Inoue 1, Zhanwei Yang 1, Masatoshi Miyake 1 School of Management, T okyo University of Science, Kuki-shi Saitama

More information

Radial basis function methods in computational finance

Radial basis function methods in computational finance Proceedings of the 13th International Conference on Computational and Mathematical Methods in Science and Engineering, CMMSE 213 24 27 June, 213. Radial basis function methods in computational finance

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

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

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

STOCHASTIC CALCULUS AND BLACK-SCHOLES MODEL

STOCHASTIC CALCULUS AND BLACK-SCHOLES MODEL STOCHASTIC CALCULUS AND BLACK-SCHOLES MODEL YOUNGGEUN YOO Abstract. Ito s lemma is often used in Ito calculus to find the differentials of a stochastic process that depends on time. This paper will introduce

More information

Computational Finance

Computational Finance Path Dependent Options Computational Finance School of Mathematics 2018 The Random Walk One of the main assumption of the Black-Scholes framework is that the underlying stock price follows a random walk

More information

Space-time adaptive finite difference method for European multi-asset options

Space-time adaptive finite difference method for European multi-asset options Space-time adaptive finite difference method for European multi-asset options Per Lötstedt 1, Jonas Persson 1, Lina von Sydow 1 Ý, Johan Tysk 2 Þ 1 Division of Scientific Computing, Department of Information

More information

Utility Indifference Pricing and Dynamic Programming Algorithm

Utility Indifference Pricing and Dynamic Programming Algorithm Chapter 8 Utility Indifference ricing and Dynamic rogramming Algorithm In the Black-Scholes framework, we can perfectly replicate an option s payoff. However, it may not be true beyond the Black-Scholes

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

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

Youngrok Lee and Jaesung Lee

Youngrok Lee and Jaesung Lee orean J. Math. 3 015, No. 1, pp. 81 91 http://dx.doi.org/10.11568/kjm.015.3.1.81 LOCAL VOLATILITY FOR QUANTO OPTION PRICES WITH STOCHASTIC INTEREST RATES Youngrok Lee and Jaesung Lee Abstract. This paper

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

2.1 Mathematical Basis: Risk-Neutral Pricing

2.1 Mathematical Basis: Risk-Neutral Pricing Chapter Monte-Carlo Simulation.1 Mathematical Basis: Risk-Neutral Pricing Suppose that F T is the payoff at T for a European-type derivative f. Then the price at times t before T is given by f t = e r(t

More information

Option Pricing. 1 Introduction. Mrinal K. Ghosh

Option Pricing. 1 Introduction. Mrinal K. Ghosh Option Pricing Mrinal K. Ghosh 1 Introduction We first introduce the basic terminology in option pricing. Option: An option is the right, but not the obligation to buy (or sell) an asset under specified

More information

Pricing Implied Volatility

Pricing Implied Volatility Pricing Implied Volatility Expected future volatility plays a central role in finance theory. Consequently, accurate estimation of this parameter is crucial to meaningful financial decision-making. Researchers

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

Cash Accumulation Strategy based on Optimal Replication of Random Claims with Ordinary Integrals

Cash Accumulation Strategy based on Optimal Replication of Random Claims with Ordinary Integrals arxiv:1711.1756v1 [q-fin.mf] 6 Nov 217 Cash Accumulation Strategy based on Optimal Replication of Random Claims with Ordinary Integrals Renko Siebols This paper presents a numerical model to solve the

More information

The Black-Scholes Model

The Black-Scholes Model The Black-Scholes Model Liuren Wu Options Markets Liuren Wu ( c ) The Black-Merton-Scholes Model colorhmoptions Markets 1 / 18 The Black-Merton-Scholes-Merton (BMS) model Black and Scholes (1973) and Merton

More information

ON AN IMPLEMENTATION OF BLACK SCHOLES MODEL FOR ESTIMATION OF CALL- AND PUT-OPTION VIA PROGRAMMING ENVIRONMENT MATHEMATICA

ON AN IMPLEMENTATION OF BLACK SCHOLES MODEL FOR ESTIMATION OF CALL- AND PUT-OPTION VIA PROGRAMMING ENVIRONMENT MATHEMATICA Доклади на Българската академия на науките Comptes rendus de l Académie bulgare des Sciences Tome 66, No 5, 2013 MATHEMATIQUES Mathématiques appliquées ON AN IMPLEMENTATION OF BLACK SCHOLES MODEL FOR ESTIMATION

More information

MATH3075/3975 FINANCIAL MATHEMATICS TUTORIAL PROBLEMS

MATH3075/3975 FINANCIAL MATHEMATICS TUTORIAL PROBLEMS MATH307/37 FINANCIAL MATHEMATICS TUTORIAL PROBLEMS School of Mathematics and Statistics Semester, 04 Tutorial problems should be used to test your mathematical skills and understanding of the lecture material.

More information

Pricing of Barrier Options Using a Two-Volatility Model

Pricing of Barrier Options Using a Two-Volatility Model U.U.D.M. Project Report 2017:13 Pricing of Barrier Options Using a Two-Volatility Model Konstantinos Papakonstantinou Examensarbete i matematik, 30 hp Handledare: Jacob Lundgren, Itiviti Group AB Ämnesgranskare:

More information

An accurate approximation formula for pricing European options with discrete dividend payments

An accurate approximation formula for pricing European options with discrete dividend payments University of Wollongong Research Online Faculty of Engineering and Information Sciences - Papers: Part A Faculty of Engineering and Information Sciences 06 An accurate approximation formula for pricing

More information

Applied Mathematics Letters. On local regularization for an inverse problem of option pricing

Applied Mathematics Letters. On local regularization for an inverse problem of option pricing Applied Mathematics Letters 24 (211) 1481 1485 Contents lists available at ScienceDirect Applied Mathematics Letters journal homepage: www.elsevier.com/locate/aml On local regularization for an inverse

More information

Forward Monte-Carlo Scheme for PDEs: Multi-Type Marked Branching Diffusions

Forward Monte-Carlo Scheme for PDEs: Multi-Type Marked Branching Diffusions Forward Monte-Carlo Scheme for PDEs: Multi-Type Marked Branching Diffusions Pierre Henry-Labordère 1 1 Global markets Quantitative Research, SOCIÉTÉ GÉNÉRALE Outline 1 Introduction 2 Semi-linear PDEs 3

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

Rohini Kumar. Statistics and Applied Probability, UCSB (Joint work with J. Feng and J.-P. Fouque)

Rohini Kumar. Statistics and Applied Probability, UCSB (Joint work with J. Feng and J.-P. Fouque) Small time asymptotics for fast mean-reverting stochastic volatility models Statistics and Applied Probability, UCSB (Joint work with J. Feng and J.-P. Fouque) March 11, 2011 Frontier Probability Days,

More information

American Option Pricing Formula for Uncertain Financial Market

American Option Pricing Formula for Uncertain Financial Market American Option Pricing Formula for Uncertain Financial Market Xiaowei Chen Uncertainty Theory Laboratory, Department of Mathematical Sciences Tsinghua University, Beijing 184, China chenxw7@mailstsinghuaeducn

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

Space time adaptive finite difference method for European multi-asset options

Space time adaptive finite difference method for European multi-asset options Computers and Mathematics with Applications 53 (2007) 1159 1180 www.elsevier.com/locate/camwa Space time adaptive finite difference method for European multi-asset options Per Lötstedt a,, Jonas Persson

More information

BROWNIAN MOTION AND OPTION PRICING WITH AND WITHOUT TRANSACTION COSTS VIA CAS MATHEMATICA. Angela Slavova, Nikolay Kyrkchiev

BROWNIAN MOTION AND OPTION PRICING WITH AND WITHOUT TRANSACTION COSTS VIA CAS MATHEMATICA. Angela Slavova, Nikolay Kyrkchiev Pliska Stud. Math. 25 (2015), 175 182 STUDIA MATHEMATICA ON AN IMPLEMENTATION OF α-subordinated BROWNIAN MOTION AND OPTION PRICING WITH AND WITHOUT TRANSACTION COSTS VIA CAS MATHEMATICA Angela Slavova,

More information