Published in: SEVENTH MEXICAN INTERNATIONAL CONFERENCE ON COMPUTER SCIENCE, IEEE-Computer Society, pp. 70-77, 2006.
Adaptive Node Refinement Collocation Method for Partial Differential Equations Jos´e Antonio Mu˜noz-G´omez Ciencias Computacionales Instituto Nacional de Astrof´ısica, ´ Optica y Electr´onica Puebla, Tonantzintla, M´exico
[email protected]
Pedro Gonz´alez-Casanova UICA-DGSCA Universidad Nacional Aut´onoma de M´exico D.F., M´exico
[email protected]
Gustavo Rodr´ıguez-G´omez Ciencias Computacionales Instituto Nacional de Astrof´ısica, ´ Optica y Electr´onica Puebla, Tonantzintla, M´exico
[email protected]
Abstract In this work, by using the local node refinement technique purposed in [2, 1], and a quad-tree type algorithm [3, 13], we built a global refinement technique for Kansa’s unsymmetric collocation approach. The proposed scheme is based on a cell by cell data structure, which by using the former local error estimator, iteratively refines the node density in regions with insufficient accuracy. We test our algorithm for steady state partial differential equations in one and two dimensions. By using thin-plate spline kernel functions, we found that the node refinement let us to reduce the approximation error and that the node insertion is only performed in regions where the analytical solution shows a high spatial variation. In addition, we found that the node refinement outperform in accuracy and number of nodes in comparison with the global classical Cartesian hrefinement technique.
1. Introduction Initially, radial radial basis functions (RBFs) were used as interpolation functions [21]. Presently, RBFs have many applications in engineering problems. We can find applications in Machine Learning, for example: datamining, knowledge discovering, object recognition in computer vision and game playing [17, 20]. In the scope of static modelling the RBF networks are used to build models, generally the activation functions employed are the Gaussian function
and the inverse multiquadric function [19]. Also, the RBFs are used in the field of pattern analysis [24]. In this research, we want to applicate the RBFs to find the numerical solution of partial differential equations. In this paper we investigate a node refinement technique to improve the spatial resolution of boundary value problems in one and two dimensions. The numerical approximation is built by means of the unsymmetric radial basis function collocation method [11, 12], which has been successfully used in a widely range of practical problems; see [28, 10, 27, 8, 6, 15, 7]. The purpose of local node refinement methods is to add nodes only on those parts of the computational domain where the numerical approximation requires to be more accurate. In fact, this strategy is particularly important when the solution presents regions with different space scale or regions with high gradients. In this article, by using a quad-tree type technique instead of a Delaunay triangulation, we built an algorithm which successful controls the spatial density distribution and node location of the global refinement algorithm. It is worth to stress, that unlike Delaunay refinement based techniques, this approach makes possible to extend it to three dimensional problems. The new scheme proposed in this work was applied to two linear partial differential equations problems: a) a 1d initial boundary problem, and b) a 2-d Poisson problem. Within this context, it was verified that this refinement method efficiently increases the spatial density distribution of nodes in regions where the solution presents sharp gradi-
ents and simultaneously keeps enough data points in smooth regions. Moreover, it was verified that the number of nodes required to meet a prescribed error value is considerably reduced when using the purposed node refinement algorithm, with respect to the uniform grid refinement method applied under the same conditions. The remainder of this paper is organized as follows: In Section 2 we describe the unsymmetric collocation method for a general boundary value problem. The node refinement strategy and the data structure used to improve the numerical approximation is explained in Section 3. In Section 4 we describe the main steps of the proposed algorithm. The numerical results for boundary value problem in one and two dimensions are exposed and discuss in Section 5. Finally, conclusions are given in Section 6.
2. Radial Basis Functions In this Section, for the purpose of completeness, we present the unsymmetric radial basis functions collocation method for the general steady-state problem in ddimensions. Consider the following boundary value problem (BVP) Lu = f in Ω ⊂ Rd ,
Bu = g on ∂Ω,
(1)
where L is an arbitrary linear differential operator, ∂Ω denotes the boundary of the domain Ω, and B is a boundary operator, which can be Dirichlet, Neumann or a mixed type. The functions f, g : Rd → R are provided. In the Kansa approach [11, 12], the problem is discretized by N collocation nodes {xi }N i=1 ⊂ Ω, which can I nodes and {xi }N be divided in interior {xi }N i=NI +1 ∈ ∂Ω i=1 boundary nodes. In order to obtain the approximate solution u ˜(x) to the exact solution u(x) of the BVP defined by (1), we first define the radial approximation u ˜(x) given by u ˜(x) =
N X j=1
λj φ(kx − xj k) + p(x),
x ∈ Rd ,
(2)
where λj are the unknown coefficients to be determined. Here φ(k·k), where k·k is the Euclidean norm, is any radial basis function (RBF). The degree of the polynomial p(x) depends of the RBF chosen, for positive definite functions the interpolant does not require a polynomial, for semipositive RBF it is necessary to incorporate p(x) in order to guarantee the non-singularity. A compressive study of RBF interpolation can be found in the book of Buhmann [5]. Substituting (2) in (1) with p(x) = 0, we obtain N X j=1
λj Lφ(kxi − xj k) = f (xi )
i = 1, . . . , NI ,
(3)
N X j=1
λj Bφ(kxi − xj k) = g(xi )
i = NI + 1, . . . , N, (4)
0 which must be solved for the unknowns {λi }N i=1 . The λ s are back-substituted into the radial approximation (2) to obtain the approximation of the solution. The linear system is solved by LU factorization. The most widely used radial basis functions are shown in Table 1, with r = kxi − xj k. In our numerical examples we have used the Thin-Plate Splines (TPS) with m = 4, which avoid the complexity introduced for the selection of the shape parameter c used in MQ, IMQ and GA.
RBF Multiquadric (MQ) Inverse Multiquadric (IMQ) Gaussian (GA) Thin-Plate Splines (TPS) Smooth Splines (SS)
Definition√ 2 + c2 φ(r, c) = r√ φ(r, c) = 1/ r2 + c2 2 φ(r, c) = e−(cr ) r m log r, m = 2, 4, 6, . . . rm , m = 1, 3, 5, . . .
Table 1. Global Radial Basis Functions To the best authors knowledge the non-singularity of the linear system (3,4) obtained by the Kansa approach is an open question. For the interpolation problem using TPS it is necessary to include a linear polynomial; see Section 3.1. In our case for the partial differential equation (PDE) approximation with TPS we do not include a polynomial, because the analytical solution resembles to a function with compact support. This fact has been reported numerically successfully [4, 14, 18].
3. Adaptive Node Refinement In the first part of this Section we describe the error indicator function to mark the nodes that will be refined. Then, we introduce the data structure used to perform the node refinement scheme for non-equally spaced data. Although the field of adaptive node methods for RBF is still a young area of research, significant contributions have already appeared in the literature. Behrens et al. [2, 1], have formulated an adaptive strategy based on local RBF interpolants in two dimensions. Their technique has been successfully applied, in a semi-Lagrangian context, to linear evolutionary PDE’s. In [25, 26], an adaptive meshfree RBF algorithm for nonlinear scalar conservation laws was developed and successfully applied to the inviscid Burger equation. Although this method is formulated in one dimension, the author points how to extend his technique to two dimensions. Other techniques [9, 23, 16], mainly in one dimension, have been also developed for different RBF. As previously pointed out, in this contribution we construct
an algorithm which combines Behrens et al. refinement method with a quad-tree type algorithm in two dimensions.
3.1
Error Indication
In this Section, we depict the error indicator proposed in [2, 1] based on local interpolation with radial basis function. For compatibility we used the same notation. We understand the error indicator as a function η(x) with domain in the current node set, which assign a positive value to each node. This values mimic the local approximation quality around of each point, and serves to determine where the approximate solution u ˜(x) require more accuracy. Let Ξ the current node set from the initial knots distribution. From each node x ∈ Ξ we select a set of neighboring nodes Nx \x ∈ Ξ. We construct a local interpolant I u ˜(x) based on Nx \x, using the equation (2) plus a polynomial of degree 1 with a TPS as kernel function. Based on the numerical approximation u ˜(x) and the local interpolant I u ˜(x) we define the error indicator η(x) = |˜ u(x) − I u ˜(x)|,
(5)
which assign a significance value η(x) to each node x ∈ Ξ. The value of η(x) is small when the surroundings values of u ˜(x) are similar or when can be represented by a linear function. On the other hand, a high value η(x) commonly indicates that the numerical approximation around of u ˜(x) has a sharp variation, which generally correspond to regions with high gradient. Based on the error indicator η(x), now we can define the rule to flag the nodes to be refined. Definition A Let η ∗ =max η(x) be for all x, and let θref > 0 a threshold value. We say that a node x ∈ Ξ is flagged to be refined if η(x) > θref · η ∗ . This definition can be understood as: only the nodes which has an error upper a threshold value, based on the percentage θref ∈ (0, 1), are marked to be refined. The refinement strategy illustrated above, is applied in an iterative refinement algorithm, where at each step we solve the analyzed PDE problem, and with the numerical approximation u ˜(x) obtained, we perform the refinement scheme. This algorithm is described in detail in the next Section.
3.2
contains a node; more details in [3, 13]. Throughout this work the terms of cell refinement and node refinement are used indifferently. Based on the local error indicator η(x) we flagged the cells to be refined. For each cell marked for refinement, four nodes are inserted. This strategy allows us to obtain a greater density of nodes in the zones with high gradient.
Adaptive Cells
The main difference with respect to [2, 1] is the data structure used to localizes and insert the nodes. In our work we does not employ a Delaunay triangulation or his dual Voronoi to search and insert the nodes respectively. The domain Ω is divided in a non overlapping cell by cell structure as shown in Figure 1, the center of each cell
Figure 1. Illustration of the cell refinement in two dimensions, it is observed that the neighboring cells are refined by relation 2:1 The data structure used assigns to each cell a pointer to its natural 4-neighbors: up, down, right and left. In order to construct the RBF local interpolator I u ˜(x), the set of neighbor nodes Nx of a point xc is obtained from its naturals 4-neighbors. In addition, the neighboring nodes in the diagonals are included: up-right, up-left, down-right and downleft. Keeping explicitly the reference to its natural 4neighbors by each cell structure, we are increasing in 32 bytes the cost of storage in memory. Nevertheless, the complexity to search his neighboring nodes is O(1). The cell structure described above can be applied to one dimension stationary problems. Where, the node refinement strategy consists in the insertion of two nodes by each node marked to be refined. That is to say, let x0 < x1 < · · · < xN and let xi the flagged node to be refined. For each flagged node, it is inserted a node to the left and right of xi xl xr
= xi + 21 (xi+1 − xi ), = xi−1 + 12 (xi − xi−1 ),
and xi is eliminated. It should be observed that the utilized data structure can be extended to three or more dimensions, and together with
the error indicator, consist in a truly meshfree scheme for non-equally spaced data for higher dimensions. The sketch of the extension of the proposed approach to higher dimensions is illustrated in the next two paragraphs. The cell structure described in this section also is known as a quadtree type data structure. In this hierarchical data structure each node can have up to 4 children, and permit us to partition the data in two dimensions recursively by means of squares or rectangles. The extension to three dimensions is made by means of the data structure called octree, in where each node contains up to 8 children. Each cell represents a cube, and it serves us to partition the data in three dimensions recursively; see [22] for a comprehensive study for a two and three dimensional hierarchical data structure for spatial decomposition. For higher dimensions, we could use the data structure called k-dimensional tree (kd-tree) to partition recursively the n-dimensional data, this approach is based on splitting the planes that are perpendicular to one of the coordinate system axes. The error indicator function, described in Section 3.1, is based on the local interpolation with radial basis functions. The RBFs are insensitive to spatial dimensions: φ : Rd → R. In consequence, it is possible to use the same error indicator function in higher dimensions, the unique modification is to considerer a correct degree of the polynomial p(x) used in (2); see [5].
4
General Scheme
In this Section we integrate the error indicator and the scheme based on cells, in order to construct a general algorithm that allows us to solve numerically problems of initial boundary value with local spatial refinement using radial basis functions. The sketch of the algorithm is given by: • Initialize the coarse node distribution • Iterate until convergence – Solve the PDE problem with RBF – Perform the adaptive refinement scheme In this work the convergence is reached when the root mean square (l2 ) or the infinity error (l∞ ) is lower than a given fixed value τ v u N u1 X t (˜ u i − u i )2 , l2 = N i=1 l∞ = max|˜ ui − ui |,
for all i,
where u ˜i = u ˜(xi ) and ui = u(xi ), with xi ∈ Rd , represent the numerical and exact solution respectively.
The proposed algorithm is compound of two blocks: numerical solution of the PDE for non-equally spaced nodes, and the scheme of local refinement in 2-d. To the best of authors knowledge, the second block described has not been used in the context of radial basis functions. This is the first step to find out a general scheme of a block structured refinement for 3-d problems with complex geometries. For a simple iteration of the algorithm, the analyzed PDE is resolved by the unsymmetric collocation method. In this way, we obtain the approximate solution u ˜(x) for every node of the domain Ω; see Section 2. Based on the numerical solution obtained, it is built the error indicator η(x) in order to determine the nodes that will be refined; see Section 3.1. Finally, the flagged nodes are refined employing the cell structure described in Section 3.2. Each module described above are in a different executable files and the interface is made by means of binary files. This modularity permit us to extend the functionality of the algorithm proposed without having to change all the programs. The software is available upon request to the first author. The program was written in C and compiled with gcc version 3.3.1 without any special flag. The computations were carried out in a dedicated computer Intel Xeon (3 GHz, 1G MB, running Linux). The outputs of the program are text files, for data display we use a Matlab software which take each text file as input and generate as output a visual representation of the data.
5. Results and Discussion The aim of this section is to obtain the numerical solution of a boundary value problems with the node refinement scheme proposed. For this purpose we analyze two boundary value problems in one and two dimensions. In addition, we investigate the accuracy of the node refinement scheme in comparison with a uniform grid distribution.
5.1
Example 1-d
Consider the following partial differential equation in one dimension uxx (x) = f (x),
x ∈ Ω ⊂ R,
(6)
where Ω=[0,1], with Dirichlet boundary conditions u(x) = g(x),
x ∈ ∂Ω.
(7)
The subindexes in uxx denote the second partial derivative with respect to x. The analytic solution is given by u(x) = tanh(η(x − 0.5)),
(8)
with η > 0, the function f (x) is expressed as
35
f (x) = −2ηu(x)(η − ηu(x)2 ).
(9)
30
The shape parameter η, allows us to control the degree of smoothness of the analytic solution. Increasing the value of the coefficient η it is obtained a discontinuity in 0.5. Consider a distribution of 34 equally spaced nodes, with a threshold refinement value θref = 0.1, the stop criterion is established when l∞ < 10 × 10−3 . We defined the coefficient η=500, from which we obtain a high gradient in the analytic solution without arriving at to the discontinuity. Table 2 shows the decreasing of the error as the refinement algorithm is iterated; see Section 4. Iteration 0 1 2 3 4 5 6
l∞ 0.968643 0.912644 0.172233 0.415363 0.014681 0.001712 0.000352
N 34 45 74 98 158 172 194
25
20
15
10
5
0
Figure 2 shows the reconstruction of the numerical approximation with the node refinement scheme. It can be observed from this graph, that the zone of high gradient is well captured. 1
0.8
0.6
0.4
0.2
0
−0.2
−0.4
−0.6
−0.8
0.1
0.2
0.3
0.4
0.5
0.6
0.7
0.8
0.9
0.2
0.3
0.4
0.5
0.6
0.7
0.8
0.9
1
we moved away of the point 0.5 the node distribution is diminishes. This gradual diminution of nodes correspond to the imposed restriction 2:1 in the algorithm. In the flat zones of the analytical solution, we do not required of many nodes to obtain a good numerical approximation.
Table 2. Decreasing of the error vs Iterations.
0
0.1
Figure 3. Histogram of the nodes distribution.
l2 0.559801 0.533539 0.084677 0.249337 0.008472 0.000305 0.000211
5.1.1
−1
0
1
Adaptive vs Non-Adaptive
In this experiment, we compare the adaptive node refinement scheme vs the uniform grid distribution to meet the same error. The test was carry out using a coefficient η=1000, with and without node refinement. Figure 4 shows two graphs in a loglog scale, in the x-axis we show the number of nodes and in y-axis correspond to the root mean square error. The global refinement consist in successive increments in the number of nodes in the interval [0, 1], where the nodes belongs to the set {100, 200, . . . , 1400}. As we can see from Figure 4, for to reach the same root mean square error, the node refinement require less nodes in comparison with the global refinement. Therefore, the node refinement improve the computational throughput. In Table 3 shown the global h-refinement and local hrefinement to reach the same l2 error. This corresponds to the final nodes displayed in Figure 4. Scheme Local h-refinement Global h-refinement
N 249 1400
l∞ 8.151e-04 3.546e-03
l2 4.086e-04 4.160e-04
Figure 2. Reconstruction of u(x) after the node refinement algorithm. The distribution of the nodes of Figure 2 is showed in Figure 3. From the last picture, it can be observed that near the point 0.5 we obtain a greater nodes density, and when
Table 3. Comparison between global hrefinement and local h−refinement. In the second and fourth column of Table 3, it is observed
that the local scheme of refinement has an efficiency of 82% in the number of nodes to reach the same root mean square, in comparison with the scheme of global h-refinement. In order to meet the same l2 -error, see Table 3, the local h-refinement scheme requires an 82% less nodes in comparison with the required nodes of the global h-refinement technique. In the third column of Table 3 it is observed that the norm l∞ is approximately one order of magnitude better than the obtained with the global refinement. In order to achieve a similar error with the global refinement, we require of 2700 nodes distributed uniformly, obtaining an error l∞ =8.281e04. This is approximately to 10 times more than the number of nodes required with the local adaptive technique. This difference in the number of nodes is dramatical since the asymmetric collocation method generates a dense matrix, and when is solving with a direct methods the algorithm complexity is O(N 3 ).
Figure 5 shows the shape of the analytical solution. As we can observe from this graph, near to the axes x = 0 and y = 0, the analytical solution have a region with a high gradient, similar to a boundary layer problem. Outside this zone a flat region is obtained. The determination of a good numerical approximation near the boundary is not a trivial problem, since the high spatial variation.
0
10
global h − refinement local h − refinement
−1
log10 RMS
10
Figure 5. Analytic solution of Poisson problem. −2
10
−3
10
4.086e−04 −4
10
2
3
10
10 Number of nodes log10 N
Figure 4. Comparison between local hrefinement and global h-refinement.
5.2
Example 2-d
Consider the following Poisson problem in two dimensions ∂2u ∂2u + 2 = f in Ω ⊂ R2 , (10) ∂x2 ∂y u = u(x, y), together with Dirichlet boundary conditions u = g on ∂Ω,
Iteration 0 2 4 6 8 10 12
N 324 460 803 1111 1463 2646 3776
l2 0.043148 0.021939 0.008232 0.003424 0.002493 0.001170 0.000553
l∞ 0.141574 0.076647 0.041500 0.034594 0.007224 0.006585 0.004722
(11)
where Ω=[0, 1]2 . The functions f, g : R2 → R are determined using the analytical solution u(x, y) = e−50x + e−50y .
The stop criterion is established when l∞ < 5 × 10−3 , with an initial node distribution of N =324 equally spaced nodes, and θref = 0.3 as a threshold value for the node refinement scheme. In Table 4 is showed the diminishing of the error in the numerical approximation as the algorithm of node refinement is iterated; see Section 4. In the first column the iteration number is showed, the number of nodes is displayed in the second column. The third and fourth column corresponds to the measurements of the error using the norms l2 and l∞ respectively.
(12)
Table 4. Decreasing of the error vs. iterations for Poisson problem. It is observed from the third and fourth column of Table
4, that as the number of iterations is increased, both types of error are diminished. Reaching the objective to reduce the approximation error by means of a local scheme of node refinement. It can be observed from Figure 6, that the cells where refined in an incremental way. The refined zones are near the axes x = 0 and y = 0, which corresponds to the zones in where the greater spatial variation in the analytic solution exists. Therefore, the indicator function η(x) permit us to detect regions where exists a high spatial variation, conforming a best spatial resolution in that regions and obtaining a reduction in the approximation error.
Figure 6. Adaptive cells for 2-d Poisson problem at different iterations={0,4,8,12}.
As it was observed, from Table 4 it can be deduced that it is possible to reduce the approximation error when the iteration is increased. However, for further iterations, iterations>12, the a-posterior error does not appears in the zone of the high gradient. In this case, the maximum error appears near the axis x = 1 and y = 1. This problem has not been solved in the present work and will be the subject of future research. In order to compare the results obtained by using node adaptive versus non-adaptive techniques, we solved the same Poisson problem with a uniform grid distribution. Let N = 3844 be equally spaced nodes, which are divided into NI = 3600 interior nodes and NF = 244 boundary nodes. In this case, the obtained error is l2 =0.015945 and l∞ =0.031331. Recall that the number of nodes used in the Cartesian grid case, is similar to the one obtained as a result of the adaptive nodes algorithm; see Table 4. Also note that the
error in the adaptive case is l2 =0.000553 and l∞ =0.004722. From this comparison it turns out that the local node refinement strategy improves the numerical approximation by simultaneously reducing the cost of a global mesh refinement.
6. Conclusions In this work we proposed an adaptive node refinement scheme for steady state partial differential equations by using the unsymmetric radial basis function collocation method. The local refinement technique is based on the work developed on the works [2, 1, 3, 13]. The scheme proposed it is a truly meshfree method for node adaptivity. The use of a quad-tree algorithm, instead of a Delaunay technique as purposed by Behrens et al., makes it possible to generalize our approach to three dimensional problems. The node adaptivity was proved to be successful for two boundary value problems in one and two dimensions, this approach showed that the node refinement permit us to capture regions with high gradients, without to insert additional nodes in the regions of low gradients. The computational 1d experiments showed that is possible to achieve a similar root mean square error to the accomplished with the classical Cartesian h-refinement scheme, but employing a fewer number of nodes. Thus, we could improve the computational effort. The bottleneck of the proposed approach is in the LU factorization used to solve the linear system of equations, which is obtained by the discretization of the partial differential equations. A way to reduce the computational effort is to use a refinement method based on the nonhomogeneous part of the PDE. Preliminary results have shown favorable outcomes. The above strategy is a first step to obtain a general scheme for a block structured refinement in 3-d.
7. Acknowledgements The authors wish to thank the support provide from INAOE and UNAM to develop this research. The first author extend his thanks to the Consejo Nacional de Ciencia y Tecnolog´ ıa of Mexico (CONACyT) for supporting this work under grant 145052. This work was partially supported by the CONACyT under the project CONACyT2002-C01-4022. Finally, we thank the reviewers for their constructive comments which helped to improve the quality of this paper.
References [1] J. Behrens and A. Iske. Grid-free adaptive semi-lagrangian advection using radial basis functions. Computers and Mathematics with Applications, 43(3-5):319–327, 2002.
[2] J. Behrens, A. Iske, and S. P¨ ohn. Effective node adaption for grid-free semi-lagrangian advection. In T. Sonar and I. Thoma, editors, Discrete Modelling and Discrete Algorithms in Continuum Mechani, pages 110–119, Berlin, 2001. Logos Verlag. [3] M. J. Berger and A. Jameson. Automatic adaptive grid refinement for the euler equations. American Institute of Aeronautics and Astronautics, 23(4), 1985. [4] I. Boztosun and A. Charafi. An analysis of the linear advection-diffusion equation using mesh-free and meshdependent methods. Engineering Analysis with Boundary Elements, 26(10):889–895, 2002. [5] M. D. Buhmann. Radial Basis Functions: Theory and Implementations. Cambridge Monographs on Applied and Computational Mathematics, 2003. [6] A. H.-D. Cheng, M. A. Golberg, E. J. Kansa, and G. Zammito. Exponential convergence and h-c multiquadric collocation method for partial differential equations. Numerical Methods Partial Differential Equations, 19(5):571–594, 2003. [7] P. Chinchapatnam, K. Djidjeli, and P. Nair. Unsymmetric and symmetric meshless schemes for the unsteady convection-diffusion equation. Computer Methods in Applied Mechanics and Engineering, 195(19-22):2432–2453, 2006. [8] G. Fasshauer. Newton iteration with multiquadrics for the solution of nonlinear pdes. Computers and Mathematics with Applications, 43(3–5):423–438, 2002. [9] Y. C. Hon. Multiquadric collocation method with adaptive technique for problems with boundary layer. Appl. Sci. Comput., 6(3):17–184, 1999. [10] Y.-C. Hon, K. F. Cheung, X.-Z. Mao, and E. J. Kansa. Multiquadric solution for shallow water equations. Journal of Hydraulic Engineering, 125(5):524–533, 1999. [11] E. J. Kansa. Multiquadrics—a scattered data approximation scheme with applications to computational fluiddynamics. I. surface approximations and partial derivative estimates. Computers and Mathematics with Applications, 19(8-9):127–145, 1990. [12] E. J. Kansa. Multiquadrics—a scattered data approximation scheme with applications to computational fluid-dynamics. II. solutions to parabolic, hyperbolic and elliptic partial differential equations. Computers and Mathematics with Applications, 19(8-9):147–161, 1990. [13] W. A. Keats and F. Lien. Two-dimensional anisotropic cartesian mesh adaptation for the compressible euler equations. International Journal for Numerical Methods in Fluids, 46(11):1099–1125, 2004. [14] J. Li and C. Chen. Some observations on unsymmetric radial basis function collocation methods for convection-diffusion problems. International Journal of Numerical Methods in Engineering, 57(8):1085–1094, 2003. [15] J. Li, H. D. A. Cheng, and C. Ching-Shyang. A comparison of efficiency and error convergence of multiquadric collocation method and finite element method. Engineering Analysis with Boundary Elements, 27(3):251–257, 2003. [16] L. Ling and M. R. Trummer. Adaptive multiquadric collocation for boundary layer problem. Journal of Computational and Applied Mathematics, 188(2):265–282, 2006.
[17] T. M. Mitchel. Machine Learning. McGraw-Hill, 1997. [18] J. A. Mu˜noz-G´ omez, P. Gonz´ alez-Casanova, and G. Rodr´ ıguez-G´ omez. Domain decomposition by radial basis functions for time dependent partial differential equations. Proceedings of Advances in Computer Science and Technology: IASTED, pages 105–109, 2006. [19] O. Nelles. Nonlinear System Identification. Springer-Verlag, 2001. [20] T. Poggio and F. Girosi. Networks for approximation and learning. Proc. IEEE, 78(9):1481–1497, 1990. [21] M. J. D. Powell. Radial basis functions for multivariate interpolation. A review. In IMA Conference on Algorithms for Approximation of Functions and Data, pages 143–167, 1987. [22] H. Samet. The quadtree and related hierarchical data structures. Computing Surveys, 16(2), 1984. [23] S. A. Sarra. Adaptive radial basis function methods for time dependent partial differential equation. Applied Numerical Mathematics, 54(1):79–94, 2005. [24] J. Shawe-Taylor and N. Cristianini. Kernel Methods for Pattern Analysis. Cambridge University Press, 2004. [25] Z. Wu. Dynamically knots setting in meshless method for solving time dependent propagations equation. Computer Methods in Applied Mechanics and Engineering, 193(1214):1221–1229, 2004. [26] Z. Wu. Dynamical knot and shape parameter setting for simulating shock wave by using multi-quadric quasiinterpolation. Engineering Analysis with Boundary Elements, 29(4):354–358, 2005. [27] M. Zerroukat, K. Djidjeli, and A. Charafi. Explicit and implicit meshless methods for linear advection-diffusion-type partial differential equations. International Journal of Numerical Methods in Engineering, 48(1):19–35, 2000. [28] M. Zerroukat, H. Power, and C. S. Chen. A numerical method for heat transfer problems using collocation and radial basis function. International Journal for Numerical Methods in Engineering, 4(7):1263–1278, 1998.