Next Article in Journal
On the Achievable Stabilization Delay Margin for Linear Plants with Time-Varying Delays
Next Article in Special Issue
Mixed Order Fractional Differential Equations
Previous Article in Journal / Special Issue
Stability of a Monomial Functional Equation on a Restricted Domain
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

An Investigation of Radial Basis Function-Finite Difference (RBF-FD) Method for Numerical Solution of Elliptic Partial Differential Equations

1
Department of Mathematics, Faculty of Science, Mahidol University, Bangkok 10400, Thailand
2
Centre of Excellence in Mathematics, Commission on Higher Education, Ministry of Education, Si Ayutthaya Road, Bangkok 10400, Thailand
*
Author to whom correspondence should be addressed.
Mathematics 2017, 5(4), 54; https://doi.org/10.3390/math5040054
Submission received: 2 September 2017 / Revised: 13 October 2017 / Accepted: 17 October 2017 / Published: 23 October 2017
(This article belongs to the Special Issue Operators of Fractional Calculus and Their Applications)

Abstract

:
The Radial Basis Function (RBF) method has been considered an important meshfree tool for numerical solutions of Partial Differential Equations (PDEs). For various situations, RBF with infinitely differentiable functions can provide accurate results and more flexibility in the geometry of computation domains than traditional methods such as finite difference and finite element methods. However, RBF does not suit large scale problems, and, therefore, a combination of RBF and the finite difference (RBF-FD) method was proposed because of its own strengths not only on feasibility and computational cost, but also on solution accuracy. In this study, we try the RBF-FD method on elliptic PDEs and study the effect of it on such equations with different shape parameters. Most importantly, we study the solution accuracy after additional ghost node strategy, preconditioning strategy, regularization strategy, and floating point arithmetic strategy. We have found more satisfactory accurate solutions in most situations than those from global RBF, except in the preconditioning and regularization strategies.

1. Introduction

For several decades, numerical solutions of partial differential equations (PDEs) have been studied by researchers in many different areas of science, engineering and mathematics. The common mathematical tools that are used to solve these problems are finite difference and finite element methods. These traditional numerical methods require the data to be arranged in a structured pattern and to be contained in a simply shaped region, and, therefore, these approaches does not suit multidimensional practical problems. The Radial basis function (RBF) method is viewed as an important alternative numerical technique for multidimensional problems because it contains more beneficial properties in high-order accuracy and flexibility on geometry of the computational domain than classical techniques [1,2,3]. The main idea of the RBF method is approximating the solution in terms of linear combination of infinitely differentiable RBF ϕ , which is the function that depends only on the distance to a center point x ̲ and shape parameter ε . More precisely, we approximate the solution as:
s ( x , ε ) = j = 1 N λ j ϕ ( x x j 2 , ε ) ,
where x j , j = 1 , , N are the given centers. For simplicity, we set ϕ ( r , ε ) = ϕ ( x x ̲ 2 , ε ) . Some common RBFs in the infinitely differentiable class are listed in Table 1.
For the case of interpolation of function y = f ( x ) , the coefficients { λ j } j = 1 N are determined by enforcing the following interpolation condition:
s ( x i , ε ) = f ( x i ) = y i , i = 1 , 2 , , N .
This condition results in an N × N linear system:
[ A ( ε ) ] λ 1 λ N = y 1 y N ,
where the elements of A ( ε ) are a j , k = ϕ ( x j x k 2 , ε ) . Note that the system matrix A ( ε ) is known to be nonsingular if the constant shape parameter ε is used and is ill-conditioned for small values of shape parameter [4,5].
The concept of RBF interpolation can also be implemented for solving elliptic PDE problems. For the global RBF method, we assume the solution in the form of Equation (1). Then, the coefficients λ j are determined by enforcing the PDE and boundary conditions. Unlike the case of interpolation, the system matrix of this case does not guarantee to be nonsingular and is also ill-conditioned for small values of shape parameter [1,6]. Additionally, according to numerical evidence, the global RBF scheme requires high computational cost and memory requirements for large scale problems [3,7]. Therefore, the radial basis function-finite difference (RBF-FD) concept, which is a local RBF scheme, was developed by combining many benefits of the RBF method and traditional finite difference approximations. Similar to the finite difference approach, the key idea is approximating the differential operator of solutions at each interior node by using a linear combination of the function values at the neighboring node locations and then determining the FD-weights so that the approximations become exact for all the RBFs that are centered at the neighboring nodes. Straightforward algebra will then show that the FD-weights can be obtained by solving the linear system, for which the system matrix is the same as matrix A in Equation (2). The invertibility of A also implies that FD-weights can always be computed. After the calculation at all interior nodes, the approximate solution can be computed from the linear system of equations, for which the RBF-FD system matrix is sparse and therefore can be effectively inverted. Note that the RBF-FD method that we described can be efficiently and applicably implemented with large scale practical problems such as the global electric circuit within the Earth’s atmosphere problem [8], steady problems in solid and fluid mechanics [9,10,11], chemotaxis models [12], and diffusion problems [13,14].
In the first part of this work, the numerical solution of elliptic PDEs by using the RBF-FD method with IQ, MQ, IMQ, and GA RBF is compared to the results of the global RBF scheme. It will show that the accuracy of both global and local methods does not depend on the choice of RBFs, and the RBF-FD method with small stencils can obtain the same level of accuracy as the global RBF method. However, the RBF-FD method is algebraically accurate in exchange for low computational cost and needs more additional techniques to improve the accuracy [10,14]. Thus, in the latter part of this work, we will aim to research improving the accuracy of the RBF-FD method by using different ways to formulate the RBF-FD method. In particular, the effects of the number of nodes and stencils on the accuracy of numerical solutions of the RBF-FD method are investigated. According to [7,15], the global RBF method can improve the accuracy significantly for small values of shape parameter by using the regularization technique and extended precision floating point arithmetic to reduce the poor conditions, but how well these techniques can improve the accuracy of RBF-FD method is not yet fully explored in the literature. Therefore, the study of the RBF-FD method with these techniques will be included in this work as well.

2. Methodology

2.1. RBF Collocation Method

In this section, the global RBF scheme for solving the PDE problem called the RBF collocation method is introduced. Let Ω R d be a d-dimensional domain and Ω be the boundary of the domain. Consider the following elliptic PDE problem defined by:
L u ( x ) = f ( x ) in   Ω ,
u ( x ) = g ( x ) on   Ω ,
where L is a differential operator. Suppose that N is the number of center points in Ω , for which N I points of them are the interior points. A straight RBF-based collocation method is applied by assuming the solution u ( x ) as:
u ( x ) j = 1 N λ j ϕ ( x x j 2 , ε ) .
Consequently, collocation with the PDE at the interior points and the boundary condition at the boundary points provide the following results:
L u ( x i ) j = 1 N λ j L ϕ ( x i x j 2 , ε ) = f ( x i ) , i = 1 , 2 , , N I , u ( x i ) j = 1 N λ j ϕ ( x i x j 2 , ε ) = g ( x i ) , i = N I + 1 , N I + 2 , , N .
The coefficients { λ j } j = 1 N can be solved from the corresponding system of equations with the coefficient matrix structured as:
L ϕ ϕ [ λ ] = f g .

2.2. RBF-FD Method

We will next present an outline of the RBF along with finite-difference (RBF-FD) formulation for solving PDE Equation (3).
First, let us look at a classical central finite difference method for approximating the derivative of function u ( x , y ) with respect to x. Let the derivative at any grid point ( i , j ) of rectangular grid be written as
u x | ( i , j ) k { i 1 , i , i + 1 } w ( k , j ) u ( k , j ) ,
where u ( k , j ) is the function value at the grid point ( k , j ) , the unknown coefficients w ( k , j ) are computed using polynomial interpolation or Taylor series, while the set of nodes { ( i 1 , j ) , ( i , j ) , ( i + 1 , j ) } is a stencil in the finite difference literature. For any scattered nodes, the restriction of the structured grid is overcome by setting the approximation of the function derivative to be a linear combination of function values on scattered nodes in the stencil; however, the methodology for computing the coefficients of finite difference formulas for any scattered points with dimensions of more than one has the problem of well-posedness for polynomial interpolation [16]. Thus, the combination of RBF and finite difference methodology (RBF-FD) is introduced to overcome the well-posedness problem.
To derive RBF-FD formulation, recall that, for a given set of distinct nodes x i R d , i = 1 , 2 , , n , and a corresponding function values u ( x i ) , i = 1 , , n , the RBF interpolation is of the form:
u ( x ) j = 1 n λ j ϕ ( x x j 2 , ε ) .
The RBF interpolation Equation (6) can alternatively be written in Lagrange form as:
u ( x ) j = 1 n χ ( x x j 2 ) u ( x j ) ,
where χ ( x x j 2 ) satisfies the following condition:
χ ( x x j 2 ) = 1 if   x = x j , 0 if   x x j , j = 1 , , n .
The key idea of the RBF-FD method is to approximate the linear differential operator of function L u ( x ) at each interior node as a linear combination of the function values at the neighboring node locations. For example, L u ( x ) at any node, say x 1 is approximated by an RBF interpolation Equation (7) with centres placed on the node itself and some n 1 nearest neighbor nodes of x 1 , say x 2 , x 3 , , x n . These set of n nodes is called the stencil or support region for the node x 1 . For deriving RBF-FD formula at the node x 1 , we approximate L u ( x 1 ) by taking the linear differential operator L on the both sides of the RBF interpolation Equation (7) i.e.,
L u ( x 1 ) j = 1 n L χ ( x 1 x j 2 ) u ( x j ) .
As in finite difference methodology, this approximation can be rewritten in the form:
L u ( x 1 ) j = 1 n w ( 1 , j ) u ( x j ) ,
where the RBF-FD weights w ( 1 , j ) = L χ ( x 1 x j 2 ) , j = 1 , , n .
In practice, the main difference between finite difference methodology and RBF-FD is how to compute the weights w ( 1 , j ) in Equation (8). While finite difference method enforces Equation (8) to be exact for polynomials 1 , x , x 2 , , x n 1 , the RBF-FD weights are computed by assuming that the approximations Equation (8) become exact for all the RBFs ϕ that are centered at each node in stencil, i.e., we assume that Equation (8) becomes exact for function u ( x ) = ϕ ( x x k 2 , ε ) , k = 1 , 2 , , n . In the RBF-FD case, this assumption leads to an n × n linear system:
ϕ ( x 1 x 1 2 , ε ) ϕ ( x 2 x 1 2 , ε ) ϕ ( x n x 1 2 , ε ) ϕ ( x 1 x 2 2 , ε ) ϕ ( x 2 x 2 2 , ε ) ϕ ( x n x 2 2 , ε ) ϕ ( x 1 x n 2 , ε ) ϕ ( x 2 x n 2 , ε ) ϕ ( x n x n 2 , ε ) w ( 1 , 1 ) w ( 1 , 2 ) w ( 1 , n ) = L ϕ ( x 1 x 1 2 , ε ) L ϕ ( x 1 x 2 2 , ε ) L ϕ ( x 1 x n 2 , ε ) .
Note that the system matrix is invertible, and, therefore, the RBF-FD weight can always be calculated, while the system matrix for the finite difference case is not guaranteed to be invertible.
After we obtain RBF-FD weights, substituting the approximation Equation (8) into the elliptic PDE Equation (3) at node x 1 gives:
j = 1 n w ( 1 , j ) u ( x j ) = f ( x 1 ) .
After that, we repeat this procedure at each of the interior nodes and substitute the approximations into the elliptic PDE Equation (3). Then, we obtain:
j = 1 n w ( i , j ) u ( x j ) = f ( x i ) , i = 1 , 2 , , N I ,
where N I is the number of interior points. After substituting the function values u ( x j ) in Equation (9) with boundary condition whenever x j is the boundary point, we obtain a linear system of equations, which can be written in matrix form as:
B u = F ,
where u is the vector of the unknown function at all the interior nodes. Note that the matrix B is sparse, well-conditioned and can hence be effectively inverted.

3. Main Result

3.1. Solution Accuracy for Elliptic PDEs

The main result section provides better understanding on the computational process. Let Ω R 2 be a 2-dimensional domain and Ω be the boundary of Ω . The elliptic PDE that we want to investigate is presented as the following:
2 u ( x ̲ ) + a ( x , y ) u x ( x ̲ ) + b ( x , y ) u y ( x ̲ ) + c ( x , y ) u ( x ̲ ) = f ( x ̲ ) , x ̲   in   Ω ,
u ( x ̲ ) = g ( x ̲ ) , x ̲   on   Ω .
In numerical experiments, the solution u ( x ̲ ) is known and normalized so that max Ω | u ( x ̲ ) | = 1 . Supposing that the RBF approximation is denoted by s ( x ̲ , ε ) , then the error in a max norm is measured by:
Max Error ( ε ) = max Ω | s ( x ̲ , ε ) u ( x ̲ ) | .

3.2. Results: A Comparison of a Global RBF Collocation Method and RBF-FD Method with Various RBFs

In this section, the global RBF collocation method and RBF-FD method will be first investigated with several RBFs by applying them to the following elliptic PDE:
2 u R u x = f ( x , y ) ,
where R = 3 , f ( x , y ) and the Dirichlet boundary condition are computed from the exact solution as shown in Equation (15):
u ( x , y ) = exp ( 0 . 5 R x ) sin ( 0 . 5 R y ) .
For this problem, we consider the PDE with the computational and evaluational domain of a unit disk with 394 uniformly scattered data points as shown in Figure 1. In our first experiment, we compare the results from using the implementation of global RBF scheme and RBF-FD method with stencil size = 13. The results of the computation of the global RBF collocation method and RBF-FD method, which is the local RBF scheme, are shown in Figure 2.
Figure 2a shows the results of the computation of RBF collocation using IQ, IMQ, MQ, and GA radial basis functions, and Figure 2b shows the results of the computation of the RBF-FD method. Considering the global RBF scheme, all four of RBF seem to provide the same level of accuracy and fluctuated graph of max error for small values of shape parameter, while there is a little bit of difference in accuracy and smooth curve of the graph for the large values of shape parameter. The IQ, IMQ and MQ RBFs have similar behaviour of error’s curves; however, the GA radial basis function has a different behaviour of error and gives the least error over the considered range of shape parameter for this problem. Note that all of them are spectrally accurate and the graph of error is oscillated since the small shape parameter makes the system matrix of global RBF collocation ill-conditioned, and, therefore, the numerical solution is computed inaccurately. This ill-conditioning problem will be more severe if more nodes are used. Due to this fact, the global RBF-scheme does not suit large scale problems.
For the RBF-FD case, all four of RBFs seem to provide the same level of accuracy for all shape parameters in the considered range. In particular, all of them have similar behaviour of error graphs and algebraic accuracy. For the large values of shape parameter, there is no significant differences of error between global and local RBF methods; however, the error of the global RBF scheme is more accurate by about two digits of accuracy than the RBF-FD method for the small values of shape parameter. Note that the graph of the error for the RBF-FD method does not oscillate for the small shape parameter because the system matrix at each node has better conditioning than the global RBF scheme for small stencil size. This fact makes the RBF-FD approach more appropriate for PDE problems with a large number of nodes.

3.3. Results: A Comparison of the RBF-FD Method with Different Numbers of Nodes and Stencils

From the previous section, the results show that the accuracy of RBF-FD is less than the accuracy of the global RBF scheme for the same number of nodes. However, the RBF-FD method is applicable and efficient for large scale problems. We hope that the increasing of the number of nodes will also help improve the accuracy for the case of the global RBF method, with the conditions for system matrix rapidly increased as well for the case of the RBF scheme [7,17]. Additionally, we expect that the accuracy will be more accurate whenever the stencil size increases. To ascertain this idea, we will consider the elliptic PDE given by:
2 u R ( u x + u y ) = f ( x , y ) .
In this case, R = 2 , f ( x , y ) and Dirichlet boundary condition are computed from the exact solution as shown in Equation (17):
u ( x , y ) = ( e R x y 1 ) ( e R 1 ) .
For numerical experiments, we consider this problem in the computational and evaluational domain of a unit disk with uniformly scattered points. In our first experiment, the number of nodes are varied while the stencil size is fixed equal to 25, and then the effect of the number of nodes on the accuracy is compared. As for the second, the experiment is done in the opposite direction. The stencil sizes are varied while the number of nodes is fixed equal to 394, and then the effect of the stencil sizes on the accuracy is compared.
The results of computation using IQ-RBF when the number of nodes are varied and the stencil size is fixed are shown in Figure 3a. All of the results seem to provide the same level of accuracy for large values of shape parameter, while there are improvements on accuracy for the small shape parameter. These results provide a good simple way for improving accuracy. However, we need to be careful lest the ill-conditioning problem would arise if the stencil size is too large. For the case of varying the stencil sizes and the number of nodes being fixed as shown in Figure 3b, the results show that the more nodes used in the computation, the more accurate results can be achieved regardless of the shape parameter values. These results are also similar to the case of the global RBF method. In practical problems, this strategy of improving accuracy is very effective for the RBF-FD method with small enough stencil size since the sparse RBF-FD system matrix is well-conditioned and can be effectively inverted for a large number of nodes. However, this strategy does not suit a global RBF approach because the condition number of the system matrix will grow rapidly as the number of nodes increases and this will make the numerical solution inaccurate.

3.4. Results: A Comparison of the RBF-FD Method with Strategies on PDE and Shape Parameter

In this section, the RBF-FD method with strategies on PDE and shape parameter are compared to the normal RBF-FD scheme. The elliptic PDE that we consider here is given by
2 u + exp ( ( x + y ) ) u = f ( x , y ) ,
where f ( x , y ) and the Dirichlet boundary condition are computed from the exact solution as shown in Equation (19):
u ( x , y ) = sinh ( x 2 + y 2 ) .
In this problem, the computations are implemented with the 395 uniformly scattered points and stencil size equal to 50.
● Method 1 : Normal RBF-FD scheme
As we discussed in Section 2.2, a straightforward RBF-FD method can be implemented for approximating the differential operator L by
L u ( x j ) i = 1 n w ( j , i ) u ( x i ) ,
for each interior node x j , j = 1 , 2 , , N . After obtaining the FD-weights, we substitute the function values u ( x j ) from the boundary condition, and then a system of equations as shown in Equation (10) can be formed which can be written in matrix form as
B u = F ,
where u is the vector of the unknown function value at all of the interior nodes. Note that the matrix B is sparse and well-conditioned and can hence be effectively inverted.
● Method 2 : RBF-FD method with ghost nodes strategy
One of the simple ways to improve accuracy of numerical solutions is applying the PDE on boundary nodes. According to the global RBF method, the error seems to be largest near the boundary of the computational domain. This problem can be fixed by getting more information there by applying the PDE at the boundary nodes [1]. In order to match the number of unknowns and equations, additional nodes, called ghost nodes, are added. The centers of these ghost nodes should be placed outside the boundary. For simplicity, we let the center points be denoted by z j , where
z j = x j , j = 1 , 2 , , N , a   point   outside   Ω , j = N + 1 , N + 2 , , N + N B ,
where N B is the number of boundary nodes. After that, a straightforward RBF-FD scheme is implemented by approximating the differential operator L by
L u ( x j ) i = 1 n w ( j , i ) u ( x i ) ,
for all node x j , j = 1 , 2 , , N . Note that the search for stencils must be applied to all nodes z j . After obtaining the FD-weights and substituting the function values u ( x j ) from the boundary condition, a system of equations as shown in Equation (10) can be formed, which can be written in matrix form as
B u = F ,
where u is the vector of the unknown function value at all of the interior nodes and points outside the boundary. Note that the matrix B is sparse and well-conditioned and can hence be effectively inverted. In this problem, we use the additional 64 ghost nodes defined by x n = 1 . 1 exp ( 2 n π i 64 ) , n = 1 , 2 , , 64 .
● Method 3 : RBF-FD method with preconditioning strategy
A variation that may improve the accuracy of the numerical solution is using the different values of shape parameter on each stencil. According to numerical evidence, RBF methods usually provide better accuracy if their system matrix is ill-conditioned. For computation with double precision, the shape parameter can be selected for each stencil so that the condition number is between 10 13 and 10 15 [12] because the error curve of the corresponding range of the shape parameter is the smooth curve before beginning to oscillate after that, as shown in Figure 2a. The following pseudocode will be used to select the shape parameter in this problem so that the condition number is in the desired range:
K = 0, Kmin = 1.0 × 1013, Kmax = 1.0 × 1015, shape = initial shape, increment = 0.01
  while K < Kmin or K > Kmax :
    form B
    K = condition number of B
    if K < Kmin
      shape = shape - increment
    elseif K > Kmax
      shape = shape + increment.
        
Figure 4 shows the results of computation using IQ-RBF with strategies on PDE and shape parameter, compared to the normal RBF scheme. The ghost nodes strategy seems to provide the same level of accuracy for large values of shape parameter, while there is a significant improvement on accuracy for the small shape parameter. Note that using the additional ghost nodes strategy does not significantly affect the condition number of the system matrix. Therefore, for the practical problem, this approach can be implemented effectively to improve the error of numerical solution near the boundary. For the preconditioning strategy, the results show that, regardless of the initial shape parameter, this strategy can provide acceptable accurate results. Therefore, this approach is an applicable and effective strategy for choosing the shape parameter for the large scale practical problems.
After we choose the shape parameter, a normal RBF-FD method can be implemented for approximating the derivative and then forming a linear system for finding the approximate solution.

3.5. Results: A Comparison of RBF-FD Method with Additional Strategies for Reducing the Ill-Conditioning Problem

In the previous section, the RBF-FD method with ghost nodes and preconditioning strategies is applied for obtaining acceptable accurate results and reducing the accuracy of numerical solutions near the boundary. This section aims to improve the accuracy through another manipulation, i.e., by focusing on reducing the ill-conditioned problem for small values of shape parameters. To clarify this idea, we will investigate two alternative strategies called regularization and extended precision floating point arithmetic. The following elliptic PDE will be studied here :
2 u + x u x + y u y ( 4 x 2 + y 2 ) u = f ( x , y ) ,
where f ( x , y ) and the Dirichlet boundary condition are computed from the same solution as shown in Equation (21)
u ( x , y ) = exp ( ( x 2 + 0 . 5 y 2 ) ) .
● Strategy 1 : Regularization
For each stencil, a simple regularization technique can be used to reduce the effects of the poor conditioning of the RBF system matrix by solving the regularized system
B y = f
instead of the following system
A x = f ,
where B = A + μ I . The regularization parameter μ is a small positive constant and I is an identity matrix. This approach can be used to solve effectively the ill-conditioning problem of the global RBF collocation method and give accurate results for small values of shape parameters, as shown in [15,18]. In this problem, we set μ = 5 × 10 15 .
● Strategy 2 : Extended precision floating point arithmetic
Recently, computer systems usually implement the IEEE 64-bit floating point arithmetic standard, which is referred to as double precision. According to [7], the global RBF method gains more benefit when it is implemented with extended precision, which provides more digits of accuracy than double precision. In particular, this approach also keeps the simplicity of the RBF method. In this work, the authors used the Multiprecision Computing Toolbox for Matlab (MCT) [19] to provide extended precision for the Matlab program and used quadruple precision (34 digits of precision) in this problem.
For numerical experiments, this problem is implemented with the computational and evaluational domain of a unit disk with 394 scattered data points and stencil size equal to 50. Figure 5 shows the results of computation using IQ-RBF with regularization and extended precision floating point arithmetic strategies, compared to the normal RBF-FD method. Unfortunately, the regularization seems to provide the same level of accuracy as the RBF-FD method without regularization, although this technique provides a significant improvement on accuracy compared to the global RBF method. However, for the extended precision strategy, the results show that this technique provides a significant improvement on accuracy at the same level as the global RBF method.

4. Future Work

RBF-FD method can also be easily extended to solve time-dependent PDEs by using the method of line such as the Runge–Kutta method (RK4) to solve the problem after the PDE is discretized in space with the RBF-FD method. For example, consider the diffusion problem given by
u t = ν 2 u + γ u 2 ( 1 u ) ,
where ν = 0 . 5 , γ = 2 , with the Dirichlet boundary and initial condition is taken from the exact solution
u ( x , y ) = 1 1 + exp ( x + y t ) .
To attack this problem, the Laplace operator 2 is discretized by the RBF-FD method as we mentioned in Section 2.2. After we obtain the results, the remaining part will be ODE, the same as the following form
u t = D u + γ u 2 ( 1 u ) ,
where D is the RBF-FD system matrix, which is obtained from discretization of the Laplace operator and u is the vector of the unknown function at all of the interior nodes. At this point, the fourth-order Runge–Kutta method (RK4) can be applied to solve the problem. The results that are implemented with the computational and evaluational domain of a unit disk with 394 scattered data points, stencil size equal to 13, and shape parameter equal to 0.6 are shown in Table 2.
Note that the RBF-FD method also gives reasonable numerical accuracy for time-dependent problems. However, many questions about eigenvalue stability of the RBF-FD method for time-dependent PDE problems in general have not yet been fully explored in the literature and need more study in future work.

5. Discussion

By using the RBF-FD method, we were able to solve large scale PDE problems due to the fact that RBF-FD has its own strengths related to feasibility and computational cost. We have found that accuracy can still be achieved at the same level of global RBF in the ill-conditioned system matrix for nodes. Although the RBF-FD method does not contain the same spectral accuracy as global RBF, it will give acceptable accuracy for large scale problems for which the global RBF can not be implemented. We also note that the accuracy can be improved by the increasing of nodes and stencil sizes. This strategy of improving accuracy is very effective with the RBF-FD method with small enough stencil size since the sparse RBF-FD system matrix is well-conditioned and can effectively be inverted for a large number of nodes. However, we need to be careful about an ill-conditioning problem arising if the stencil size is too large. The ghost node and preconditioning strategies are introduced to improve the accuracy of numerical solutions. Using the additional ghost node strategy does not significantly affect the condition number of the system matrix. Therefore, for the practical problem, this approach can be implemented effectively to reduce the errors of numerical solutions near boundaries. Results show that, regardless of the initial shape parameter, preconditioning strategy can provide acceptable accurate results. Improving the accuracy by reducing the ill-conditioning problem for small shape parameter is also an interesting idea. From experimental results, the extended precision provides significant improvement in accuracy. Unfortunately, regularization strategy fails to yield better accuracy than that of the plain RBF-FD.
Table 3 shows the results of solving PDE Equation (20) by using the RBF-FD method at a shape parameter equal to 0.4 with additional different strategies, which are presented in this work. In this case, preconditioning and regularization techniques yield the same level of accuracy as the normal RBF-FD method, while the other strategies can improve accuracy by around one digit of accuracy. Note that all of these strategies can be used together as a mixed strategy for obtaining high accuracy. However, the issues about how to choose the optimal shape parameter for obtaining the most accurate results and how to solve the ill-conditioned problem for small values of shape parameter are still open problems needing further investigation.

6. Conclusions

In this paper, we have found that the combination of the Radial Basis Function and the finite difference (RBF-FD) method with either additional Ghost Node strategy or additional Extended Precision strategy can help improve the accuracy in solving the elliptic partial differential equations, while the Preconditioning and Regularization strategies are found to be of little avail for our purpose.

Acknowledgments

This research was funded by the Faculty of Science, Mahidol University, Bangkok, Thailand.

Author Contributions

Suranon Yensiri and Ruth J. Skulkhu designed and developed the research. Suranon Yensiri was responsible for simulating the results by the MATLAB programming (version 9.1.0.441655 (R2016b), The MathWorks Inc., Natick, Massachusetts, United States). Both authors wrote this paper and contributed to editing and revising the manuscript.

Conflicts of Interest

The authors declare no conflict of interest.

References

  1. Larsson, E.; Fornberg, B. A numerical study of some radial basis function based solution methods for elliptic PDEs. Comput. Math. Appl. 2003, 46, 891–902. [Google Scholar] [CrossRef]
  2. Li, J.; Cheng, H.-D.; Chen, C.-S. A comparison of efficiency and error convergence of multiquadric collocation method and finite element method. Eng. Anal. Bound. Elem. 2003, 27, 251–257. [Google Scholar] [CrossRef]
  3. Sarra, S.A.; Kansa, E.J. Multiquadrics Radial Basis Function Approximation Methods for The Numerical Solution to Partial Differential Equations; Tech Science Press: Duluth, GA, USA, 2010. [Google Scholar]
  4. Fasshauer, G.E. Meshfree Approximation Methods with Matlab; World Scientific: Singapore, 2007. [Google Scholar]
  5. Micchelli, C. Interpolation of scattered data: Distance matrices and conditionally positive definite functions. Constr. Approx. 1986, 2, 11–22. [Google Scholar] [CrossRef]
  6. Hon, Y.C.; Schaback, R. On unsymmetric collocation by radial basis functions. Appl. Math. Comput. 2001, 119, 177–186. [Google Scholar] [CrossRef]
  7. Sarra, S.A. Radial basis function approximation methods with extended precision floating point arithmetic. Eng. Anal. Bound. Elem. 2011, 35, 68–76. [Google Scholar] [CrossRef]
  8. Bayona, V.; Flyer, N.; Lucas, G.M.; Baumgaertner, A.J.G. A 3-D RBF-FD solver for modeling the atmospheric global electric circuit with topography (GEC-RBFFD v1.0). Geosci. Model Dev. 2015, 8, 3007–3020. [Google Scholar] [CrossRef]
  9. Shan, Y.; Shu, C.; Qin, N. Multiquadric finite difference (MQ-FD) method and its application. Adv. Appl. Math. Mech. 2009, 5, 615–638. [Google Scholar]
  10. Tolstykh, A.I.; Lipavskii, M.V.; Shirobokov, D.A. High-accuracy discretization methods for solid mechanics. Arch. Mech. 2003, 55, 531–553. [Google Scholar]
  11. Tolstykh, A.I.; Shirobokov, D.A. On using radial basis functions in finite difference mode with applications to elasticity problems. Comput. Mech. 2003, 33, 68–79. [Google Scholar] [CrossRef]
  12. Sarra, S.A. A Local Radial Basis Function method for Advection-Diffusion-Reaction equations on complexly shaped domains. Appl. Math. Comput. 2012, 218, 9853–9865. [Google Scholar] [CrossRef]
  13. Hosseini, B.; Hashemi, R. Solution of Burgers’ equation using a local-RBF meshless method. Int. J. Comput. Meth. Eng. Sci. Mech. 2011, 12, 44–58. [Google Scholar] [CrossRef]
  14. Shankar, V.; Wright, G.B.; Fogelson, A.L.; Kirby, R.M. A radial basis function (RBF) finite difference method for the simulation of reaction-diffusion equations on stationary platelets within the augmented forcing method. Int. J. Numer. Methods Fluids 2014, 75, 1–22. [Google Scholar] [CrossRef]
  15. Sarra, S.A. Regularized symmetric positive definite matrix factorizations for linear systems arising from RBF interpolation and differentiation. Eng. Anal. Bound. Elem. 2014, 44, 76–86. [Google Scholar] [CrossRef]
  16. Wright, G.B.; Fornberg, B. Scattered node compact finite difference-type formulas generated from radial basis functions. J. Comput. Phys. 2006, 212, 99–123. [Google Scholar] [CrossRef]
  17. Sarra, S.A. A numerical study of the accuracy and stability of symmetric ans asymmetric RBF collocation methods for hyperbolic PDEs. Numer. Methods Partial Differ. Equ. 2008, 24, 670–686. [Google Scholar] [CrossRef]
  18. Sarra, S.A. The Matlab radial basis function toolbox. J. Open Res. Softw. 2017, 5, 8. [Google Scholar] [CrossRef]
  19. Advanpix. Multiprecision Computing Toolbox for Matlab, Version 4.4.1.12566 for 64-bit Windows. Available online: http://www.advanpix.com (accessed on 17 August 2017).
Figure 1. The computational and evaluational domain of a unit disk with 394 uniformly scattered data points.
Figure 1. The computational and evaluational domain of a unit disk with 394 uniformly scattered data points.
Mathematics 05 00054 g001
Figure 2. The graphs of max error are presented as a function of shape parameter. They compare max error of the results of global radial basis function (RBF) and radial basis function-finite difference (RBF-FD) methods. (a) global RBF scheme; (b) local RBF scheme.
Figure 2. The graphs of max error are presented as a function of shape parameter. They compare max error of the results of global radial basis function (RBF) and radial basis function-finite difference (RBF-FD) methods. (a) global RBF scheme; (b) local RBF scheme.
Mathematics 05 00054 g002
Figure 3. The graph of the max error of the RBF-FD method with different numbers of nodes and stencils. (a) varying number of stencils (n); (b) varying number of nodes (N).
Figure 3. The graph of the max error of the RBF-FD method with different numbers of nodes and stencils. (a) varying number of stencils (n); (b) varying number of nodes (N).
Mathematics 05 00054 g003
Figure 4. The graph shows the comparing of max error among the RBF-FD method with ghost nodes, the RBF-FD method with preconditioning, and the normal RBF-FD method. In the case of the RBF-FD method with preconditioning, we plot the max error against the initial shape parameter.
Figure 4. The graph shows the comparing of max error among the RBF-FD method with ghost nodes, the RBF-FD method with preconditioning, and the normal RBF-FD method. In the case of the RBF-FD method with preconditioning, we plot the max error against the initial shape parameter.
Mathematics 05 00054 g004
Figure 5. The graphs of max error of the RBF-FD method with regularization and extended precision strategies, compared to the normal RBF-FD method.
Figure 5. The graphs of max error of the RBF-FD method with regularization and extended precision strategies, compared to the normal RBF-FD method.
Mathematics 05 00054 g005
Table 1. Radial basis functions.
Table 1. Radial basis functions.
Name of RBFAbbreviationDefinition
MultiquadricsMQ ϕ ( r , ε ) = 1 + ( ε r ) 2
Inverse MultiquadricsIMQ ϕ ( r , ε ) = 1 1 + ( ε r ) 2
Inverse QuadraticsIQ ϕ ( r , ε ) = 1 1 + ( ε r ) 2
GaussiansGA ϕ ( r , ε ) = e ( ε r ) 2
Table 2. The results of solving the partial differential equation (PDE) Equation (24) with the radial basis function-finite difference (RBF-FD) method at t = 5 , 10 , 15 .
Table 2. The results of solving the partial differential equation (PDE) Equation (24) with the radial basis function-finite difference (RBF-FD) method at t = 5 , 10 , 15 .
t51015
Max Error2.19 × 10 4 2.57 × 10 4 2.71 × 10 4
Table 3. The results of solving the PDE Equation (20) by using the RBF-FD method at a shape parameter equal to 0.4 with different additional strategies.
Table 3. The results of solving the PDE Equation (20) by using the RBF-FD method at a shape parameter equal to 0.4 with different additional strategies.
MethodMax Error ( × 10 7 )
Normal RBF-FD ( N = 400 , n = 25 )42.4
Normal RBF-FD ( N = 400 , n = 50 )4.75
Normal RBF-FD ( N = 800 , n = 25 )8.80
Ghost Node ( N = 400 , n = 25 , 64 ghost nodes)5.63
Preconditioning ( N = 400 , n = 25 )40.5
Regularization ( N = 400 , n = 25 )38.1
Extended Precision ( N = 400 , n = 25 )6.34

Share and Cite

MDPI and ACS Style

Yensiri, S.; Skulkhu, R.J. An Investigation of Radial Basis Function-Finite Difference (RBF-FD) Method for Numerical Solution of Elliptic Partial Differential Equations. Mathematics 2017, 5, 54. https://doi.org/10.3390/math5040054

AMA Style

Yensiri S, Skulkhu RJ. An Investigation of Radial Basis Function-Finite Difference (RBF-FD) Method for Numerical Solution of Elliptic Partial Differential Equations. Mathematics. 2017; 5(4):54. https://doi.org/10.3390/math5040054

Chicago/Turabian Style

Yensiri, Suranon, and Ruth J. Skulkhu. 2017. "An Investigation of Radial Basis Function-Finite Difference (RBF-FD) Method for Numerical Solution of Elliptic Partial Differential Equations" Mathematics 5, no. 4: 54. https://doi.org/10.3390/math5040054

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop