Abstract

We briefly review and investigate the performance of various boundary conditions such as Dirichlet, Neumann, linear, and partial differential equation boundary conditions for the numerical solutions of the Black-Scholes partial differential equation. We use a finite difference method to numerically solve the equation. To show the efficiency of the given boundary condition, several numerical examples are presented. In numerical test, we investigate the effect of the domain sizes and compare the effect of various boundary conditions with pointwise error and root mean square error. Numerical results show that linear boundary condition is accurate and efficient among the other boundary conditions.

1. Introduction

We briefly review and perform a comparison study for Dirichlet, Neumann, linear, and partial differential equation (PDE) boundary conditions (BCs) for the Black-Scholes (BS) partial differential equations. Let and denote the price of the underlying asset and time, respectively. Then, the value of the option is governed by the BS equation [1]: where is a constant volatility of the asset and is a constant riskless interest rate. The final condition is the payoff function at expiry : It is difficult to find the analytic solutions of (1) and (2) for exotic options. Therefore we need to use a numerical approximation. To obtain an approximation of the option value, one can compute a solution of the BS equations (1) and (2) using a finite difference method (FDM) [28], finite element method [911], finite volume method [1214], a fast Fourier transform [1517], and also their optimal BC [18]. Here, we consider FDM approach to solve the BS PDE. See [1, 1924] for more details for FDM applied to option pricing. To solve the BS PDE using the FDM, we need to truncate the infinite domain to a finite domain and have to use an artificial BC. To reduce large errors in the numerical solution due to this approximation of the BCs, the truncated domain must be large enough. Thus the purpose of this paper is to investigate the effects of several BCs on the numerical solutions for the BS PDE (1) and (2).

The outline of the paper is as follows. In Section 2, we formulate the generalized version of the BS PDE. And we explain five cases which are Dirichlet I, Dirichlet II, Neumann, linear, and PDE BCs. Section 3 presents the results of the numerical experiments and the conclusions are drawn in Section 4.

2. Numerical Solution

Let be the value of the underlying asset price and let be the time to expiry; then (1) becomes a more natural initial value problem with an initial condition for . Here we truncate the infinite domain into a finite domain since the infinite domain cannot be represented in the computer [23].

2.1. Discretization with Finite Difference Method

We apply the FDM for solving (3) numerically. Let us first discretize the given computational domain as a uniform grid with a spatial step size and a temporal step size , where is the number of subintervals (see Figure 1) and is the number of time steps.

Let us denote the numerical approximation of the solution as where and . By applying the fully implicit-in-time and space-centered difference scheme to (3), we have We can rewrite (5) by where , , , and .

In order to solve the linear system (6), we need to know and for all . At , we simply set . Next, we present five different boundary conditions for specifying the values of .

2.2. Boundary Conditions

In solving the BS equation numerically, there are many BCs. In this section, we introduce five BCs, which are used to solve the BS equation. We focus on two options: European call option and cash-or-nothing option. The payoff functions are given by for the European call option and the cash-or-nothing option, respectively. Here is the strike price and denotes the return value at expiration if the option is in-the-money. We have closed-form solutions for these options. For the European call option, the closed-form solution of the BS equation is where is the cumulative distribution function for the standard normal distribution [25]. For the cash-or-nothing option, the closed form solution is

2.2.1. Dirichlet I Boundary Condition

From (9), we can observe that and are close to one when is large enough. Therefore, Dirichlet BC for the European call option is defined by for a sufficiently large . By (12), we use . Using this, we can rewrite (6) as Likewise, we have for the cash-or-nothing option.

2.2.2. Dirichlet II Boundary Condition

The other Dirichlet boundary condition is simply setting the boundary values to be fixed all the time with the payoff value. For the max call option, we set : For the cash-or-nothing option, we set . This boundary condition was used in [26].

2.2.3. Neumann Boundary Condition

To specify values for the derivative of the solution at the boundary of the spatial domain, we have the following equation from (9): Therefore, for a sufficiently large , we assume which we call by Neumann BC for European call option. Equation (16) can be discretized as ; that is, . Therefore, we have Similarly, applying BC in terms of the first derivative of for the cash-or-nothing option, we can get from (11). Therefore, we can assume for a sufficiently large . This represents Neumann BC for cash-or-nothing option. We now replace (19) with the one-sided derivative ; that is, .

2.2.4. Linear Boundary Condition

Linear boundary condition assumes that the second derivative of the option value with respect to the underlying asset price vanishes to zero for the large value of the asset price. To demonstrate this, we consider (9) at the right end of the domain. The second derivative value is given by If the asset price approaches to the large value , we assume which we call by linear BC for European call option. Equation (21) can be discretized as . By this relation, we obtain the boundary value as . By substituting this in (3), we get Similarly, for the cash-or-nothing option, we have from (11). Therefore, for a sufficiently large , we have In this case, we can obtain the same BC as European call option.

2.2.5. PDE Boundary Condition

Next we consider the PDE BC [23, 27]. Using the BS equation itself, we derive the BC. We use one-sided discretization: where the drift and volatility terms are discretized by using one-sided derivatives. The linear system of equations can be written in the following matrix form: where , , , and .

3. Numerical Experiments

To compare the above five BCs, we perform the numerical tests with European vanilla call option and cash-or-nothing option. Figures 2(a) and 2(b) show European call option and cash-or-nothing option prices at and on , respectively. Here, and are used. In the Appendix, we provide MATLAB codes for the closed-form solutions of these options.

In the following sections, unless otherwise specified, we use strike price , cash , the risk-free interest rate , and volatility .

3.1. Convergence Test

First, we investigate the convergence of the numerical solutions with different BCs. To show this, we calculate the root mean square error with respect to spatial and temporal step sizes. Root mean square error (RMSE) is defined by where is the number of grid points on . Here, is exact solution and is numerical solution.

Table 1 represents the RMSE of European vanilla call option with five different BCs for varying and at . As shown in Table 1, we can observe that the RMSE converges to zero with decreasing space and time step sizes. From now on, we will use the and for the following numerical tests.

3.2. Pointwise Error on Different Domain Size

To study the effects of the various BCs, we perform the numerical tests on different domain size . For comparison, we compute the pointwise error as the absolute difference between the numerical solution and the closed-form solution ; that is, .

First, we take the payoff of a European vanilla call option (7). In Figure 3, left and right columns represent the option values and the pointwise errors versus , respectively. In Figure 3, we compare the numerical results with three different domain sizes , 200, and 300. As domain size is large, there is no difference between the numerical results with five different boundary conditions and analytic solution at . Also, pointwise error in decreases when the domain size increases.

As second example, we test cash-or-nothing option. Similar to the previous case, we have same results as shown in Figure 4. When is large, the pointwise error decreases. However, when the domain size is not sufficiently large, we have gap between the analytic and numerical solutions.

Therefore, it is important to choose the domain size . Also, to reduce the numerical error, we need to choose the proper boundary condition.

3.3. Root Mean Square Error

The following numerical tests illustrate RMSE of various BCs with different and . First we consider European call option with , , , and . Figures 5(a) and 5(b) represent the RMSE against the interest rate and the volatility , respectively. Here, we use and in Figures 5(a) and 5(b), respectively. As we can observe from Figure 5(a), the RMSE increases as is large. Also, the RMSE versus has similar behavior in Figure 5(a). Through this test, we can see that Dirichlet I and Neumann BCs are more efficient than other BCs in case of and .

Now, we consider cash-or-nothing option with , , , and . Figure 6 shows the RMSE of various BCs versus and . Here, we use and in Figures 6(a) and 6(b), respectively. In this test, we can observe that Dirichlet II and Neumann BCs have lower RMSE than the other BCs for various and .

Figure 7 illustrates RMSE of various BCs versus time with European call option and cash-or-nothing option, respectively. As shown in Figure 7(a), we can see that the choice of BCs is important when is large. In addition, we can confirm that Neumann BC is efficient to reduce numerical error. Similarly, we observe that Neumann BC is efficient when is small or is large in Figure 7(b).

4. Conclusion

In this paper, we reviewed and studied the performance of the five different boundary conditions such as Dirichlet, Neumann, linear, and partial differential equation boundary conditions for the numerical solutions of the BS partial differential equation. We used a finite difference method to numerically solve the BS equation with the five different BCs. To show the efficiency of the given boundary condition, several numerical examples such as a convergence test, domain size effect, and parameter effect are presented. Numerical results suggested that the linear boundary condition is accurate and efficient among the other boundary conditions. As a future research, we will investigate the BCs on the multidimensional BS equations.

Appendix

Evaluation of European call option price from call: we describe the formula, in MATLAB code, as shown in Algorithm 1.

%  European call option
clear;clc;clf;K=100;L=3*K;T=1.0;sigma=0.35;r=0.05;Nx=L+1;dt=0.01;
Nt=round(T/dt); x=linspace(0,L,Nx); h=x(2)-x(1);payoff=max(x-K,0);
d1=(log(x/K)+(r+sigma2/2)*T)/(sigma*sqrt(T));d2=d1-sigma*sqrt(T);
exact=x.*normcdf(d1)-K*exp(-r*T).*normcdf(d2);grid on; hold on
plot(x,payoff,k-,x,exact,k-,LineWidth,1) axis image,
axis ([0 300 -12.5 220])

In a similar way, we can obtain the closed form of cash-or-nothing option, for MATLAB code as shown in Algorithm 2.

%  Cash-or-nothing options
clear;clc;clf;K=100;L=3*K;T=1;sigma=0.35;r=0.05;Nx=L+1;dt=0.01;Nt=round(T/dt);
x=linspace(0,L,Nx);h=x(2)-x(1);
for i=1:Nx
if (x(i) <= K)
payoff(i)=0.0;
else payoff(i)=1.0;
end
end
d=(log(x/K)+(r-sigma2/2)*T)/(sigma*sqrt(T));exact=1.0*exp(-r*T).*normcdf(d); grid on;
hold on;plot(x,payoff,k-,x,exact,r-,LineWidth,1)axis ([0 300 -0.05 1.05])

Conflict of Interests

The authors declare that there is no conflict of interests regarding the publication of this paper.

Acknowledgments

The first author (Darae Jeong) was supported by Basic Science Research Program through the National Research Foundation of Korea (NRF) funded by the Ministry of Education, Science and Technology (2014R1A6A3A01009812). The second author (Seungsuk Seo) and the corresponding author (Junseok Kim) were supported by The Small and Medium Business Administration (SMBA). The authors are grateful to the referees whose valuable suggestions and comments significantly improved the quality of this paper.