RBF Collocation Methods and Pseudospectral Methods

Size: px
Start display at page:

Download "RBF Collocation Methods and Pseudospectral Methods"

Transcription

1 RBF Collocation Methods and Pseudospectral Methods G. E. Fasshauer Draft: November 19, 24 Abstract We show how the collocation framework that is prevalent in the radial basis function literature can be modified so that the methods can be interpreted in the framework of standard pseudospectral methods. This implies that many of the standard algorithms and strategies used for solving time-dependent as well as time-independent partial differential equations with (polynomial) pseudospectral methods can be readily adapted for the use with radial basis functions. The potential advantage of radial basis functions is that they lend themselves to complex geometries and non-uniform discretizations. Keywords: radial basis functions, collocation, pseudospectral methods. 1 Introduction Pseudospectral (PS) methods are known as highly accurate solvers for partial differential equations (PDEs). The basic idea (see, e.g., [6 or [17) is to use a set of (very smooth and global) basis functions φ j, j = 1,..., N, such as polynomials to represent an unknown function (the approximate solution of the PDE) via u h (x) = N λ j φ j (x), x R. (1) j=1 Since most of our discussion will focus on a representation of the spatial part of the solution we ignore the time variable in the formulas for u h. We will employ standard time-stepping procedures to deal with the temporal part of the solution. Moreover, since standard pseudospectral methods are designed for the univariate case we initially limit ourselves to single-variable functions. Later we will generalize to multivariate (spatial) problems by using radial basis functions. An important feature of pseudospectral methods is the fact that one usually is content with obtaining an approximation to the solution on a discrete set of grid points x i, i = 1,..., N. One of several ways to implement the spectral method is via so-called differentiation matrices, i.e., one finds a matrix D such that at the grid points x i we have u = Du, (2) Department of Applied Mathematics, Illinois Institute of Technology, Chicago, IL 6616, USA

2 where u = [u h (x 1 ),..., u h (x N ) T is the vector of values of u h at the grid points. Frequently, orthogonal polynomials such as Chebyshev polynomials are used as basis functions, and the grid points are corresponding Chebyshev points. In this case the entries of the differentiation matrix are explicitly known (see, e.g., [17). In this paper we are interested in using (infinitely smooth) radial basis functions (RBFs) in the spectral expansion (1), i.e., φ j (x) = Φ( x x j ), where Φ is some positive definite univariate basic function. Popular choices for positive definite functions include inverse multiquadrics 1 Φ(r) =, (3) 1 + (εr) 2 Gaussians Matérn functions (see, e.g., [1) such as Φ(r) = e (εr)2, (4) Φ(r) = e εr ( (εr) 3 + 6(εr) (εr) + 15 ), (5) or compactly supported Wendland functions (which do not lend themselves to the task at hand, i.e., as generalized PS methods, since they are of limited smoothness). With some additional notational effort all that follows can also be formulated for conditionally positive definite functions such as the popular multiquadric Φ(r) = 1 + (εr) 2. (6) Above, the univariate variable r is a radial variable, i.e., r = x, and the positive parameter ε is equivalent to the well-known shape parameter used to scale the basic functions. We have chosen the representations above since then ε always results in flat basic functions for which we have the well-known trade-off principle, i.e., high accuracy at the cost of low stability or vice versa (see, e.g., [15). 2 Differentiation Matrices We now begin with a general discussion of differentiation matrices. Consider expansion (1) and let φ j, j = 1,..., N, be an arbitrary linearly independent set of smooth functions that will serve as the basis for our approximation space. If we evaluate (1) at the grid points x i, i = 1,..., N, then we get u h (x i ) = or in matrix-vector notation N λ j φ j (x i ), i = 1,..., N, j=1 u = Aλ, (7) where λ = [λ 1,..., λ N T is the coefficient vector, the evaluation matrix A has entries A ij = φ j (x i ), and u is as before. By linearity we can also use the expansion (1) to compute the derivative of u h by differentiating the basis functions d dx uh (x) = N j=1 2 λ j d dx φ j(x).

3 If we again evaluate at the grid points x i then we get in matrix-vector notation u = A x λ, (8) where u and λ are as above, and the matrix A x has entries d dx φ j(x i ), or, in the case of d radial functions, dx Φ( x x j ) x=xi. In order to obtain the differentiation matrix D we need to ensure invertibility of the evaluation matrix A. This depends both on the basis functions chosen as well as the location of the grid points x i. For univariate polynomials it is well-known that the evaluation matrix is invertible for any set of distinct grid points. In particular, if the polynomials are written in cardinal (or Lagrange) form, then the evaluation matrix is the identity matrix. For positive definite radial basis functions (an extension of) Bochner s theorem guarantees the invertibility of the matrix A for any set of distinct grid points (also non-uniformly spaced and in R d, d > 1). Cardinal RBFs, on the other hand, are rather difficult to obtain. For the special case of uniform one-dimensional grids such formulas can be found in [13. Thus we can use (7) to solve for the coefficient vector λ = A 1 u, and then (8) yields u = A x A 1 u, so that the differentiation matrix D corresponding to (2) is given by D = A x A 1. For more complex linear differential operators L with constant coefficients we can use the same argument as above to obtain a discretized differential operator (differentiation matrix) L = A L A 1, (9) where the matrix A L has entries A L,ij = Lφ j (x i ). In the case of radial basis functions these entries are of the form A L,ij = LΦ( x x j ) x=xi. In the context of spectral methods the differentiation matrix L can now be used to solve all kinds of PDEs (time-dependent as well as time-independent). Sometimes only multiplication by L is required (e.g., for many time-stepping algorithms), and for other problems one needs to be able to invert L. In the standard PS case it is known that the Chebyshev differentiation matrix has an N-fold zero eigenvalue (see [3, p.7), and thus is not invertible by itself. However, once boundary conditions are taken into consideration the situation changes (see, e.g., [17, p.67). To obtain a little more insight into the special properties of radial basis functions let us pretend to solve the (ill-posed) linear PDE of the form Lu = f by ignoring boundary conditions. An approximate solution at the grid points x i might be obtained by solving the discrete linear system Lu = f, where f contains the values of f at the grid points and L is as above. In other words, the solution at the grid points is given (see (9)) by u = L 1 f = A(A L ) 1 f, 3

4 and we see that invertibility of L (and therefore A L ) would be required. As mentioned above, the differentiation matrix for pseudospectral methods based on Chebyshev polynomials is singular. This is only natural since the problem of reconstructing an unknown function from the values of its derivative alone is ill-posed. However, if we use radial basis functions it is well known in the RBF literature that the matrix A L is invertible provided a positive definite basic function is used, the differential operator is elliptic and no boundary conditions are present. Therefore, the basic differentiation matrix L for RBF-based pseudospectral methods is invertible. The observation just made suggests that RBF methods are sometimes too good to be true. They may deliver a solution even for ill-posed problems. This is a consequence of the variational framework in which the RBF method can be formulated (see, e.g., [18), i.e., RBF methods possess a built-in regularization capability. 3 PDEs with Boundary Conditions via Pseudospectral Methods First we discuss how the linear elliptic PDE problem Lu = f in Ω with Dirichlet boundary condition u = g on Γ = Ω can be solved using spectral methods if the basis functions do not already satisfy the boundary conditions (see, e.g., [17, Program 36). Essentially, one starts with the differentiation matrix L based on all grid points x i, and then replaces the diagonal entries corresponding to boundary points with ones and the remainder of those rows with zeros. This corresponds to enforcing the boundary condition u = g explicitly. By reordering the rows and columns of the resulting matrix we obtain a block matrix of the form [ M P L Γ =, (1) I where the non-zero blocks M and I are of size (N N B ) (N N B ) and N B N B, respectively, and N B denotes the number of grid points on the boundary Γ. The solution of the PDE with boundary conditions on the grid is then given by the solution of the block linear system L Γ u = [ f g, (11) where the vectors f and g collect the values of f and g at the respective grid points. We can decompose the vector of grid values of the solution into u = [u Ω, u Γ T, where u Ω collects the values in the interior of the domain Ω and u Γ collects the values on the boundary. Solving (11) for u Γ = g and substituting this back in we obtain u Ω = M 1 (f P g), 4

5 or, for homogeneous boundary conditions, u Ω = M 1 f. We now see that we need to be able to decide whether the matrix M is invertible. In the case of Chebyshev polynomial basis functions and the second-derivative operator d2 dx 2 coupled with different types of boundary conditions this question has been answered affirmatively by Gottlieb and Lustman ([8, or, e.g., Section 11.4 of [3). Program 15 of [17 also provides a discussion and an illustration of one such problem. 4 PDEs with Boundary Conditions via RBFs Once boundary conditions are added to the PDE Lu = f then two collocation approaches are commonly used in the RBF community. For the sake of simplicity we restrict our discussion to Dirichlet boundary conditions. 4.1 Kansa s Non-symmetric Collocation Method In Kansa s non-symmetric method [11 one starts with the expansion u h (x) = N λ j φ j (x), x Ω R d, (12) j=1 just as before (cf. (1)). However, the coefficient vector λ is now determined by inserting (12) into the PDE and boundary conditions and forcing these equations to be satisfied at the grid points x i. The collocation solution is therefore obtained by solving the linear system [ ÃLà [ f λ = g, (13) where f and g are as above, and the (rectangular) matrices ÃL and à are of the form à L,ij = Lφ j (x i ) = LΦ( x x j ) x=xi, i = 1,..., N N B, j = 1,..., N, à ij = φ j (x i ) = Φ( x i x j ), i = N N B + 1,..., N, j = 1,..., N. Assuming that the system matrix is invertible one then obtains the approximate solution (at any point x) by using the coefficients λ in (12). However, it is known that certain grids do not allow invertibility of the system matrix in (13) (see, e.g., the counterexamples in [1). In [12 an iterative algorithm is suggested that adaptively builds grids for which the matrix is invertible. 4.2 An RBF-based Pseudospectral Method I If we are interested in the solution at the grid points only, then (using λ from (13)) [ ÃLà u = Aλ = A 1 [ f g 5

6 with evaluation matrix A such that A ij = φ j (x i ) as above. This suggests that (according to our discussion in Section 2) the discretized differential operator L based on the grid points x i, i = 1,..., N, and basis functions φ j, j = 1,..., N, is given by Indeed, we have [ ÃLÃ [ ÃLÃ L Γ = A 1. [ A 1 M P = I with the same blocks M, P, and I as above. To see this we introduce the following notation: A = a T 1. a T N with column vectors a i and a 1 j this notation implies and A 1 = [ a a 1 N [ ÃLÃ such that a T i a 1 j = δ ij. For Kansa s matrix from (13) = a T L,1. a T L,N N B a T N N B +1 where we have used an analogous notation to denote the rows of the block ÃL. Now the discretized differential operator based on the non-symmetric collocation approach is given by [ ÃLÃ A 1 = = a T L,1. a T L,N N B a T N N B +1. a T N Ã L A 1 I ÃA 1 I }{{} =. a T N, [ a a 1 N Ã L A 1 B ÃA 1 B }{{} =I Here we partitioned A 1 into the blocks A 1 I with N N B columns corresponding to interior points, and A 1 B with N B columns corresponding to the remaining boundary points. Also, we made use of the fact that a T i a 1 j = δ ij. This is clearly the same as (see (1) [ M P = L I Γ, 6.

7 where M and P were obtained from the discrete differential operator L = A L A 1 = [ A L A 1 I A L A 1 B by replacing certain rows with unit vectors. We have just seen that provided we use the same basis functions φ j and the same grid of collocation points x i the non-symmetric RBF collocation approach for the solution of an elliptic PDE with Dirichlet boundary conditions followed by evaluation at the grid points is identical to a pseudospectral approach. However, neither of the two methods is well-defined in general since they both rely on the invertibility of Kansa s collocation matrix. Above we showed that we can always form the discretized differential operator [ [ ÃLà L Γ = A 1 M P = I even if Kansa s matrix is not invertible. This implies that we can safely use the non-symmetric RBF pseudospectral approach whenever inversion of the discretized differential operator is not required (e.g., in the context of explicit time-stepping for parabolic PDEs). Another interesting feature that we will illustrate below is the fact shown recently by a number of authors (see, e.g., [2, [4, [16) that in the limiting case of flat basis functions (i.e., parameter ε in (3 6)) the one-dimensional RBF interpolant yields a polynomial interpolant. Since we also mentioned earlier that the discretized differential operator L Γ is invertible if a univariate polynomial basis is used we can conclude that Kansa s collocation matrix is invertible in the limiting case ε. 4.3 A Symmetric Collocation Method A second RBF collocation method has a symmetric system matrix that is known to be invertible for all grid configurations and any positive definite basic function (see, e.g., [5 and references therein). An interesting observation will be that Kansa s matrix (actually its transpose) is the evaluation matrix for a PS approach based on the same set of basis functions used for this symmetric collocation approach. For the symmetric collocation method one uses a different basis than in (12), i.e., a different function space than for the non-symmetric case. For the same elliptic PDE and boundary conditions as above one now starts with u h (x) = N N B j=1 λ j L jφ(x) + N j=n N B +1 λ j φ j (x). (14) Since the φ j are radial functions, i.e., φ j (x) = Φ( x x j ) the functionals L j can be interpreted as an application of L to Φ viewed as a function of the second variable followed by evaluation at x j. One obtains the coefficients λ = [λ Ω, λ Γ T by solving the linear system [ [ [ ÂLL  L λω f =. (15)  g  L λ Γ 7

8 Here the blocks ÂLL and Â, respectively, are square matrices corresponding to the interaction of interior grid points with each other and boundary grid points with each other. Their entries are given by  LL,ij = [L [L Φ( x ξ ) ξ=xj, i, j = 1,..., N N B, x=x i  ij = φ j (x i ) = Φ( x i x j ), i, j = N N B + 1,..., N. The other two blocks are rectangular, and correspond to interaction of interior points with boundary points and vice versa. They are defined as  L,ij = [LΦ( x x j ) x=xi, i = 1,..., N N B, j = N N B + 1,..., N,  L,ij = [L Φ( x i x ) x=xj, i = N N B + 1,..., N, j = 1,..., N N B. As already mentioned, it is well known that the system matrix in (15) is invertible for positive definite radial functions. This implies that we can obtain the approximate solution at any point x by using the computed coefficients λ in (14). Thus this collocation method is very similar to Kansa s non-symmetric method with the notable difference that the collocation approach is well-defined. 4.4 An RBF-based Pseudospectral Method II A nice connection between the symmetric and non-symmetric collocation methods appears if we consider the symmetric pseudospectral approach. To this end we use the expansion (14) on which the symmetric collocation method is based as starting point for a pseudospectral method, i.e., u h (x) = N N B j=1 λ j L jφ(x) + N j=n N B +1 λ j φ j (x). In vectorized notation this corresponds to u h (x) = [ a T L (x) ãt (x) [ λ Ω λ Γ (16) with appropriate row vectors a T L (x) and ãt (x). Evaluated on the grid of collocation points this becomes u = [ A L à [ T λ Ω. λ Γ Here the blocks A L and ÃT of the evaluation matrix are rectangular matrices with entries A L,ij = [L Φ( x i x ) x=xj, i = 1,..., N, j = 1,..., N N B, à T ij = φ j (x i ) = Φ( x i x j ), i = 1,..., N, j = N N B + 1,..., N, corresponding to evaluation of the basis functions used in (14) at the grid points. Note that the second matrix with entries φ j (x i ) is in fact the transpose of the corresponding 8

9 block of the system matrix in (13) for Kansa s method (and thus use of the same notation is justified). Moreover, the radial symmetry of the basic functions implies that the first block of the evaluation matrix for the symmetric collocation method is again the transpose of the corresponding block in Kansa s collocation method. To see this we consider differential operators of even orders and odd orders separately. If L is a linear differential operator of odd order, then L will introduce a sign change (since it is acting on Φ as a function of the second variable). In addition, odd order derivatives (evaluated at x = x j include a factor of the form x i x j. Now, transposition of this factor will again lead to a sign change. The combination of these two effects ensures that A L = ÃT L. For even orders the effects of the operators L and L are indistinguishable. Therefore, using symmetric RBF collocation we obtain the approximate solution of the boundary value problem on the grid as [ ÃLÃ u = T [ ÂLL Â L Â L Â 1 [ f g We emphasize that this is not the solution of a pseudospectral method built on the same function space (same basis functions and same collocation points) as the symmetric RBF collocation method. For a pseudospectral method we would require the discretized differential operator. Formally (assuming invertibility of Kansa s matrix) we would have [ [ T ÂLL Â ˆL Γ = L ÃLÃ, Â L Â where we already incorporated the boundary conditions in a way analogous to our earlier discussion. The problem with the second (symmetric) pseudospectral approach is that we cannot be assured that the method itself (i.e., the discretized differential operator) is well-defined. In fact, due to the Hon-Schaback counterexample [1 we know that there exist grid configurations for which the basis used for the symmetric PS expansion is not linearly independent. Therefore, the symmetric RBF collocation approach is well-suited for problems that require inversion of the differential operator (such as elliptic PDEs). Subsequent evaluation on a grid makes the symmetric collocation look like a pseudospectral method but it may not be (since we may not be able to formulate the pseudospectral Ansatz). 5 A Unified Discussion In both the symmetric and non-symmetric collocation approaches we can think of the approximate solution as a linear combination of appropriate basis functions. In vectorized notation this can be written as. u h (x) = p(x)λ, (17) where the vector p(x) contains the basis functions at x. If we consider the nonsymmetric method these basis functions are just φ j, j = 1,..., N, while for the symmetric method they are comprised of both functions of the type φ j and L jφ (cf. (16)). 9

10 We now let D denote the linear operator that combines both the differential operator L and the boundary operator (for Dirichlet boundary conditions this is just the identity). Then we have Du h (x) = Dp(x)λ = q(x)λ (18) for an appropriately defined vector q(x). Therefore, the boundary value problem for our approximate solution is given by Du h (x) = f(x), where f is a piecewise defined function that collects the forcing functions in both the interior and on the boundary. Now we evaluate the two representations (17) and (18) on the grid of collocation points x i, i = 1,..., N, and obtain u = P λ and u D = Qλ with matrices P and Q whose rows correspond to evaluation of the vectors p(x) and q(x), respectively, at the collocation points x i. The discretized boundary value problem is then u D = Qλ = f, (19) where f is the vector of values of f on the grid. For the non-symmetric collocation approach P is the standard RBF interpolation matrix, and Q is Kansa s matrix, whereas for symmetric collocation P is the transpose of Kansa s matrix, and Q is the symmetric collocation matrix. It is our goal to find the vector u, i.e., the values of the approximate solution on the grid. There are two ways by which we can obtain this answer: 1. We solve Qλ = f for λ, i.e., λ = Q 1 f. Then we use the discretized version of (17) to get the desired vector u as u = P Q 1 f. 2. Alternatively, we first transform the coefficients, i.e., we rewrite u = P λ as λ = P 1 u. Then the discretized boundary value problem (19) becomes QP 1 u = f, and we can obtain the solution vector u by solving this system. The first approach corresponds to RBF collocation, the second to the pseudospectral approach. Both of these approaches are equivalent as long as all of the matrices involved are invertible. Unfortunately, as mentioned earlier, there are configurations of grid points for which Kansa s matrix is not invertible. This means that for the non-symmetric case (Q is Kansa s matrix) Approach 1 cannot be assured to work in general, and Approach 2 can only be used if the discretized differential operator is applied directly (but not inverted). For the symmetric approach (P is Kansa), on the other hand, Approach 1 is guaranteed to work in general, but Approach 2 may not be well-defined. 1

11 6 Numerical Experiments In this section we illustrate how the RBF pseudospectral approach can be applied in a way completely analogous to standard polynomial pseudospectral methods. Among our numerical illustrations are two examples taken directly from the book [17 by Trefethen (see Programs 35 and 36 there). We will also use a 1-D transport equation to compare the RBF and polynomial pseudospectral methods. Plots of the spectra of the respective differentiation matrices will support the theoretical results mentioned earlier which state that RBF methods tend to polynomial methods in the limit ε. We begin by giving a brief explanation of how the Contour-Padé algorithm of Fornberg and Wright [7 can be used to compute the discretized differential operators (differentiation matrices) mentioned in our earlier discussions. 6.1 Use of the Contour-Padé Algorithm with the PS Approach In its original form the Contour-Padé algorithm of Fornberg and Wright [7 allows one to stably evaluate radial basis function interpolants based on infinitely smooth RBFs for extreme choices of the shape parameter ε (in particular ε ). More specifically, the Contour-Padé algorithm uses FFTs and Padé approximations to evaluate the function s(x, ε) = p(ε)(a(ε)) 1 f (2) with p(ε) j = Φ( x x j ) and A(ε) j,k = Φ( x k x j ) at some evaluation point x (cf. the discussion in the previous section). The parameter ε is used to denote the dependence of p and A on the choice of that parameter in the basic function Φ. If we evaluate s at all of the grid points x j for some fixed value of ε, then p(ε) turns into the matrix A(ε). In the case of interpolation this exercise is, of course, pointless. However, if the Contour-Padé algorithm is adapted to replace p(ε) with the matrix A L based on the differential operator used earlier, then p(ε)(a(ε)) 1 u = A L (ε)(a(ε)) 1 u computes the values of the (spatial) derivative of u on the grid points x j. Boundary conditions can then be incorporated later as in the standard pseudospectral approach (see, e.g., [17 or our discussion in Section 3). This means that we can take standard pseudospectral code (such as that presented in [17) and replace just one subroutine, namely that which provides the differentiation matrix, by the appropriate one for radial basis functions. In the examples given below we will use both Contour-Padé and straightforward (based on LU-factorization of the collocation systems) implementations of these subroutines. 6.2 Example: 1-D Transport Equation Consider u t (x, t) + cu x (x, t) =, x > 1, t >, u( 1, t) =, u(x, ) = f(x), 11

12 with solution u(x, t) = f(x ct). The graph in Figure 1 shows the time profile of the solution for the time interval [, 1 with initial profile f(x) = 64(1 x) 3 x 3 and unit wave speed. For the computation we used Gaussian RBFs (4) and the Contour-Padé algorithm in the limiting case ε together with an implicit Euler method with time step t =.1 for the time discretization. We point out that this, of course, requires an inversion of the differentiation matrix. Recall that our earlier theoretical discussion suggested that this is possible as long as we limit ourselves to the limiting case ε and one space dimension. Also, an implementation based on an explicit Euler method showed almost identical behavior for a smaller time step so that we can be assured that the inversion was indeed justified for this particular example. The explicit Euler method, on the other hand, exhibited instabilities for the larger time step used in Figure 1. The exact stability conditions (CFL conditions) for the RBF pseudospectral method are an open problem. The spatial discretization for the solution displayed in Figure 1 was based on 19 Chebyshev points in [ 1, 1. Figure 1: Solution to transport equation based on Gaussian RBFs with Contour-Padé (ε = ), implicit Euler ( t =.1), and 19 Chebyshev points. In Figure 2 we plot the maximum errors at time t = 1 for two different time steps ( t =.1 and t =.1) and spatial discretizations consisting of 5 up to 19 points. If we use Chebyshev polynomials instead of Gaussian RBFs then the error plots look identical (and are therefore omitted). The spectra of the differentiation matrices for both the Gaussian and the Chebyshev PS approaches are plotted in Figures 3 and 4, respectively. The subplots correspond to the use of N = 5, 9, 13, 17 Chebyshev points for the spatial discretization. The plots for the Gaussian and Chebyshev methods are almost identical. There is only a slight difference in the location of the eigenvalues in the case N = 17. We point out that one 12

13 Max Error for Gaussian PS Solver of Transport Equation 1 Max Error for Gaussian PS Solver of Transport Equation error 1 1 error N N Figure 2: Errors at t = 1 for transport equation. Gaussian RBFs (ε = ), variable spatial discretization N. Implicit Euler method with t =.1 (left), t =.1 (right). of the (severe) limitations of the Contour-Padé algorithm is its guaranteed accuracy for very small problems only. Thus, already for the case N = 17 this feature is slightly visible. 6.3 Example: Allen-Cahn Equation Next, we illustrate the solution of a nonlinear reaction-diffusion equation. To be specific we adapt Program 35 of [17 involving the nonlinear Allen-Cahn equation with parameter µ, initial condition u t = µu xx + u u 3, x ( 1, 1), t, u(x, ) =.53x +.47 sin ( 32 πx ), x [ 1, 1, and non-homogeneous (time-dependent) boundary conditions u( 1, t) = 1 and u(1, t) = sin 2 (t/5). This equation has three steady solutions (u = 1,, 1) with the two nonzero solutions being stable. The transition between these states is governed by the parameter µ. In our calculations below we use µ =.1, and the unstable state should vanish around t = 3. Sample Matlab code to solve this problem using an explicit Euler discretization for the time-derivative and a Chebyshev pseudospectral differentiation matrix for the spatial derivative is listed in Table 1 (page 141 of [17). Essentially, one needs only to form the differentiation matrix for the second spatial derivative (which can be taken as the square of the first derivative matrix, i.e., D2 = D 2, see line 2 of the algorithm) and use this within the time-stepping method that incorporates the nonlinearity of the problem (see line 11). We can apply the code from [17 almost verbatim for radial basis functions. In [17 the differentiation matrix is obtained by a call to the subroutine cheb.m in line 2 13

14 % p35.m - Allen-Cahn eq. as in p34.m, but with boundary condition % imposed explicitly ("method (II)") % Differentiation matrix and initial data: 1 figure(1); 2 N = 2; [D,x = cheb(n); D2 = D^2; 3 eps =.1; dt = min([.1,5*n^(-4)/eps); 4 t = ; v =.53*x +.47*sin(-1.5*pi*x); % Solve PDE by Euler formula and plot results: 5 tmax = 1; tplot = 2; nplots = round(tmax/tplot); 6 plotgap = round(tplot/dt); dt = tplot/plotgap; 7 xx = -1:.25:1; vv = polyval(polyfit(x,v,n),xx); 8 plotdata = [vv; zeros(nplots,length(xx)); tdata = t; 9 for i = 1:nplots 1 for n = 1:plotgap 11 t = t+dt; v = v + dt*(eps*d2*v + v - v.^3); % Euler 12 v(1) = 1 + sin(t/5)^2; v(end) = -1; % BC 13 end 14 vv = polyval(polyfit(x,v,n),xx); 15 plotdata(i+1,:) = vv; tdata = [tdata; t; 16 end 17 clf, subplot( position,[ ) 18 mesh(xx,tdata,plotdata), grid on, axis([-1 1 tmax -1 2), 19 view(-6,55), colormap(1e-6*[1 1 1); xlabel x, ylabel t, zlabel u Table 1: Program 35 of [17 14

15 Im Re Figure 3: Spectra of differentiation matrices for Gaussian RBF (ε = ). N = 5, 9, 13, 17 Chebyshev points. which yields the matrix D for the discretization of the first derivative operation on the Chebyshev points. The only difference is to replace this by a call to a subroutine DRBF.m that generates the RBF differentiation matrix D = A L A 1 as explained earlier (see (9)). Thus, we replace line 2 of the algorithm with 2 N = 2; [D,x = DRBF(N); D2 = D^2; or by using second derivatives of the RBFs to generate the matrix A L, i.e., 2 N = 2; [D2,x = D2RBF(N); With the latter approach D2 will be a discretization of the second spatial derivative on the grid points (which may be arbitrarily spaced for the use with RBFs). The implementation of DRBF.m is accomplished either via the Contour-Padé algorithm of Fornberg and Wright as explained above, or by explicitly setting up a first derivative matrix A L and an evaluation matrix (i.e., interpolation matrix) A and computing its inverse. Note that the majority of the matrix computations are required only once outside the time-stepping procedure. Inside the time-stepping loop (lines 1 13) we only require matrix-vector multiplication. We point out that this approach is much 15

16 Im Re Figure 4: Spectra of differentiation matrices for Chebyshev pseudospectral method. N = 5, 9, 13, 17 Chebyshev points. more efficient than computation of RBF expansion coefficients at every time step (as suggested, e.g., in [9). Figures 5 and 6, respectively, show the solution obtained with the Gaussian RBF (with ε = via Contour-Padé) and with the Chebyshev pseudospectral method. Both spatial discretizations are based on N = 1 Chebyshev points in [ 1, 1. Clearly, a spatial discretization of only 1 points does not suffice. The metastable solution only survives for t up to about t = 2 (instead of t 3 for an accuracte solution). However, again, the RBF and polynomial PS solutions are identical. In Figures 7 and 8, respectively, we show the solution obtained via the Chebyshev pseudospectral method and via an RBF pseudospectral approach based on the Matérn function (5) with ε = 2.. These computations were based on 2 Chebyshev points, and the differentiation matrix for the RBF was obtained directly (i.e., without the Contour-Padé algorithm). We used this approach since for 2 points the Contour-Padé algorithm no longer can be relied upon. Moreover, it is apparent from the figures that reasonable solutions can also be obtained via this direct (and much simpler) RBF approach. Spectral accuracy, however, will no longer be given if ε >. The solution based on Chebyshev polynomials for N = 2 is the most accurate since the transition occurs at the correct time (i.e., at t 3) and is a little sharper. 16

17 2 1 u t x.5 Figure 5: Solution of the Allen-Cahn equation using Gaussian RBFs (ε =, N = 1). 6.4 Example: 2-D Laplace Equation Our final example is an elliptic equation. For such a problem inversion of the differentiation matrix is required. Even though this may not be warranted theoretically, we compare an RBF pseudospectral method based on the non-symmetric Kansa Ansatz with a Chebyshev pseudospectral method. As in the previous example, the Matérn RBF (5) is used (this time with ε = 2.4), and the (inverse of the) differentiation matrix is computed using standard Matlab routines. We consider the 2-D Laplace equation u xx + u yy =, x, y ( 1, 1) 2, with boundary conditions sin 4 (πx), y = 1 and 1 < x <, u(x, y) = 1 5 sin(3πy), x = 1,, otherwise. This is the same problem as used in Program 36 of [17. Figures 9 and 1 show the solution obtained via the RBF and Chebyshev pseudospectral methods, respectively. Now the spatial discretization consists of a tensor product of N = Chebyshev points. The qualitative behavior of the two solutions is very similar. While there is no advantage in going to arbitrarily irregular grid points for any of the problems presented here, there is nothing that prevents us from doing so for the RBF approach. In particular, we are not limited to using tensor product grids for higher-dimensional spatial discretizations. This is a potential advantage of the RBF pseudospectral approach over the standard polynomial methods. 17

18 2 1 u t x.5 Figure 6: Solution of the Allen-Cahn equation using the Chebyshev pseudospectral method (N = 1). 7 Summary In this paper we attempted to establish a connection between RBF collocation methods and standard (polynomial) pseudospectral methods. Our discussion revealed that for the non-symmetric (Kansa) Ansatz (12) we can always formulate the discrete differential operator [ ÃLÃ L Γ = A 1. However, we cannot ensure in general the invertibility of L Γ. This implies that the nonsymmetric RBF pseudospectral approach is justified for time-dependent PDEs (with explicit time-stepping methods). For the symmetric Ansatz (14), on the other hand, we can in general ensure the solution of Lu = f. However, it is not possible in general to even formulate the discrete differential operator [ ÂLL Â ˆL Γ = L Â L Â [ AL Ã T 1. This suggests that we should use the symmetric approach for time-dependent PDEs with implicit time-stepping as well as for time-independent PDEs. The difficulties with both approaches can be attributed to the possible singularity of Kansa s matrix which appears as discretized differential operator for the non-symmetric approach, and (via its transpose) as the evaluation matrix in the symmetric approach. Since the non-symmetric approach is quite a bit easier to implement than the symmetric approach, and since the grid configurations for which the Kansa matrix is singular seem to be very rare (see [1) many researchers (include ourselves) often prefer to 18

19 Figure 7: Solution of the Allen-Cahn equation using the Chebyshev pseudospectral method (N = 2). use the non-symmetric approach even under questionable circumstances (such as with implicit time-stepping procedures, or for elliptic problems). However, the connection to polynomials in the limiting case ε = justifies this at least for 1-D problems. Overall, the coupling of RBF collocation and pseudospectral methods obtained here has provided a number of new insights. For example, it should now be clear that we can apply many standard pseudospectral procedures to RBF solvers. However, with RBF expansions we can also take advantage of scattered (multivariate) grids as well as spatial domains with non-rectangular geometries. Thus, we now have standard procedures for solving time-dependent PDEs with RBFs. Moreover, we have illustrated that RBF pseudospectral methods for ε = are identical to Chebyshev pseudospectral methods. Future challenges include the problem of dealing with larger problems in an efficient and stable way. Thus, such issues as preconditioning and FFT-type algorithms need to be studied in the context of RBF pseudospectral methods. Some first results in this directions have been reported very recently in [14. Another possible avenue opened up by the use of RBFs instead of polynomials is the study of pseudospectral methods with moving (adaptive) grids. This will be computationally much more involved, but the use of RBFs should imply that there is no major restriction imposed by moving (scattered) grids. Acknowledgement: I would like to thank Robert Schaback for discussing with me at length the connection between the pseudospectral approach and RBF collocation, and Grady Wright for providing me with a pre-beta version of his Matlab toolbox for the Contour-Padé algorithm of [7. 19

20 Figure 8: Solution of the Allen-Cahn equation using the Matérn RBF (5) (N = 2). References [1 R. K. Beatson and H.-Q. Bui, Mollification formulas and implicit smoothing, Research Report UCDMS 23/19, University of Canterbury, 23. [2 C. de Boor, On interpolation by radial polynomials, Adv. in Comput. Math., to appear. [3 C. Canuto, M. Y. Hussaini, A. Quarteroni, and T. A. Zang, Spectral Methods in Fluid Dynamics, Springer Verlag, Berlin, [4 T. A. Driscoll and B. Fornberg, Interpolation in the limit of increasingly flat radial basis functions, Comput. Math. Appl. 43 (22), [5 G. E. Fasshauer, Solving partial differential equations by collocation with radial basis functions, in Surface Fitting and Multiresolution Methods, A. Le Méhauté, C. Rabut, and L. L. Schumaker (eds.), Vanderbilt University Press, Nashville TN, 1997, [6 B. Fornberg, A Practical Guide to Pseudospectral Methods, Cambridge Univ. Press, [7 B. Fornberg and G. Wright, Stable computation of multiquadric interpolants for all values of the shape parameter, Comput. Math. Appl. 47 (24), [8 D. Gottlieb and L. Lustman, The spectrum of the Chebyshev collocation operator for the heat equation, SIAM J. Numer. Anal. 2 (1983), no. 5, [9 Y. C. Hon and X. Z. Mao, A radial basis function method for solving options pricing model, Financial Engineering (8) 1999,

21 1.5 u(,) = Figure 9: Solution of the Laplace equation using the Matérn RBF (5) (ε = 2.4, N = 24 24). [1 Y. C. Hon and R. Schaback, On nonsymmetric collocation by radial basis functions, Appl. Math. Comput. 119 (21), [11 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, Comput. Math. Appl., 19 (199), [12 L. Ling, R. Opfer, and R. Schaback, Results on meshless collocation techniques, preprint, Universität Göttingen, 24. [13 R. B. Platte and T. A. Driscoll, Polynomials and potential theory for Gaussian radial basis function interpolation, Technical report, University of Delaware, 24. [14 R. B. Platte and T. A. Driscoll, Stabilizing radial basis function methods for time-dependent problems, Comput. Math. Appl., submitted. [15 R. Schaback, On the efficiency of interpolation by radial basis functions, in Surface Fitting and Multiresolution Methods, A. Le Méhauté, C. Rabut, and L. L. Schumaker (eds.), Vanderbilt University Press, Nashville TN, 1997, [16 R. Schaback, Multivariate interpolation by polynomials and radial basis functions, preprint, Universität Göttingen, 22. [17 L. N. Trefethen, Spectral Methods in Matlab, SIAM, Philadelphia, PA, 2. [18 H. Wendland, Scattered Data Approximation, Cambridge University Press, Cambridge, to appear. 21

22 1.5 u(,) = Figure 1: Solution of the Laplace equation using the Chebyshev pseudospectral method (N = 24 24). 22

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 43: RBF-PS Methods in MATLAB Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH 590 Chapter 43 1 Outline

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 43: RBF-PS Methods in MATLAB Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH 590 Chapter 43 1 Outline

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 40: Symmetric RBF Collocation in MATLAB Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH 590 Chapter

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 34: Improving the Condition Number of the Interpolation Matrix Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 33: Adaptive Iteration Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH 590 Chapter 33 1 Outline 1 A

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 33: Adaptive Iteration Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH 590 Chapter 33 1 Outline 1 A

More information

Meshfree Approximation Methods with MATLAB

Meshfree Approximation Methods with MATLAB Interdisciplinary Mathematical Sc Meshfree Approximation Methods with MATLAB Gregory E. Fasshauer Illinois Institute of Technology, USA Y f? World Scientific NEW JERSEY LONDON SINGAPORE BEIJING SHANGHAI

More information

A numerical study of a technique for shifting eigenvalues of radial basis function differentiation matrices

A numerical study of a technique for shifting eigenvalues of radial basis function differentiation matrices A numerical study of a technique for shifting eigenvalues of radial basis function differentiation matrices Scott A. Sarra Marshall University and Alfa R.H. Heryudono University of Massachusetts Dartmouth

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 14: The Power Function and Native Space Error Estimates Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 2: Radial Basis Function Interpolation in MATLAB Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH 590

More information

Multivariate Interpolation with Increasingly Flat Radial Basis Functions of Finite Smoothness

Multivariate Interpolation with Increasingly Flat Radial Basis Functions of Finite Smoothness Multivariate Interpolation with Increasingly Flat Radial Basis Functions of Finite Smoothness Guohui Song John Riddle Gregory E. Fasshauer Fred J. Hickernell Abstract In this paper, we consider multivariate

More information

Numerical solution of nonlinear sine-gordon equation with local RBF-based finite difference collocation method

Numerical solution of nonlinear sine-gordon equation with local RBF-based finite difference collocation method Numerical solution of nonlinear sine-gordon equation with local RBF-based finite difference collocation method Y. Azari Keywords: Local RBF-based finite difference (LRBF-FD), Global RBF collocation, sine-gordon

More information

Interpolation by Basis Functions of Different Scales and Shapes

Interpolation by Basis Functions of Different Scales and Shapes Interpolation by Basis Functions of Different Scales and Shapes M. Bozzini, L. Lenarduzzi, M. Rossini and R. Schaback Abstract Under very mild additional assumptions, translates of conditionally positive

More information

DIRECT ERROR BOUNDS FOR SYMMETRIC RBF COLLOCATION

DIRECT ERROR BOUNDS FOR SYMMETRIC RBF COLLOCATION Meshless Methods in Science and Engineering - An International Conference Porto, 22 DIRECT ERROR BOUNDS FOR SYMMETRIC RBF COLLOCATION Robert Schaback Institut für Numerische und Angewandte Mathematik (NAM)

More information

1. Introduction. A radial basis function (RBF) interpolant of multivariate data (x k, y k ), k = 1, 2,..., n takes the form

1. Introduction. A radial basis function (RBF) interpolant of multivariate data (x k, y k ), k = 1, 2,..., n takes the form A NEW CLASS OF OSCILLATORY RADIAL BASIS FUNCTIONS BENGT FORNBERG, ELISABETH LARSSON, AND GRADY WRIGHT Abstract Radial basis functions RBFs form a primary tool for multivariate interpolation, and they are

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 6: Scattered Data Interpolation with Polynomial Precision Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu

More information

Positive Definite Kernels: Opportunities and Challenges

Positive Definite Kernels: Opportunities and Challenges Positive Definite Kernels: Opportunities and Challenges Michael McCourt Department of Mathematical and Statistical Sciences University of Colorado, Denver CUNY Mathematics Seminar CUNY Graduate College

More information

c 2005 Society for Industrial and Applied Mathematics

c 2005 Society for Industrial and Applied Mathematics SIAM J. UMER. AAL. Vol. 43, o. 2, pp. 75 766 c 25 Society for Industrial and Applied Mathematics POLYOMIALS AD POTETIAL THEORY FOR GAUSSIA RADIAL BASIS FUCTIO ITERPOLATIO RODRIGO B. PLATTE AD TOBI A. DRISCOLL

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 9: Conditionally Positive Definite Radial Functions Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH

More information

A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS

A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS Proceedings of ALGORITMY 2005 pp. 222 229 A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS ELENA BRAVERMAN, MOSHE ISRAELI, AND ALEXANDER SHERMAN Abstract. Based on a fast subtractional

More information

Stability of Kernel Based Interpolation

Stability of Kernel Based Interpolation Stability of Kernel Based Interpolation Stefano De Marchi Department of Computer Science, University of Verona (Italy) Robert Schaback Institut für Numerische und Angewandte Mathematik, University of Göttingen

More information

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations Moshe Israeli Computer Science Department, Technion-Israel Institute of Technology, Technion city, Haifa 32000, ISRAEL Alexander

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 5: Completely Monotone and Multiply Monotone Functions Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH

More information

ACCURACY AND STABILITY OF GLOBAL RADIAL BASIS FUNCTION METHODS FOR THE NUMERICAL SOLUTION OF PARTIAL DIFFERENTIAL EQUATIONS. by Rodrigo B.

ACCURACY AND STABILITY OF GLOBAL RADIAL BASIS FUNCTION METHODS FOR THE NUMERICAL SOLUTION OF PARTIAL DIFFERENTIAL EQUATIONS. by Rodrigo B. ACCURACY AND STABILITY OF GLOBAL RADIAL BASIS FUNCTION METHODS FOR THE NUMERICAL SOLUTION OF PARTIAL DIFFERENTIAL EQUATIONS by Rodrigo B. Platte A dissertation submitted to the Faculty of the University

More information

Kernel-based Approximation. Methods using MATLAB. Gregory Fasshauer. Interdisciplinary Mathematical Sciences. Michael McCourt.

Kernel-based Approximation. Methods using MATLAB. Gregory Fasshauer. Interdisciplinary Mathematical Sciences. Michael McCourt. SINGAPORE SHANGHAI Vol TAIPEI - Interdisciplinary Mathematical Sciences 19 Kernel-based Approximation Methods using MATLAB Gregory Fasshauer Illinois Institute of Technology, USA Michael McCourt University

More information

A new stable basis for radial basis function interpolation

A new stable basis for radial basis function interpolation A new stable basis for radial basis function interpolation Stefano De Marchi and Gabriele Santin Department of Mathematics University of Padua (Italy) Abstract It is well-known that radial basis function

More information

Kernel B Splines and Interpolation

Kernel B Splines and Interpolation Kernel B Splines and Interpolation M. Bozzini, L. Lenarduzzi and R. Schaback February 6, 5 Abstract This paper applies divided differences to conditionally positive definite kernels in order to generate

More information

A Posteriori Error Bounds for Meshless Methods

A Posteriori Error Bounds for Meshless Methods A Posteriori Error Bounds for Meshless Methods Abstract R. Schaback, Göttingen 1 We show how to provide safe a posteriori error bounds for numerical solutions of well-posed operator equations using kernel

More information

Least Squares Approximation

Least Squares Approximation Chapter 6 Least Squares Approximation As we saw in Chapter 5 we can interpret radial basis function interpolation as a constrained optimization problem. We now take this point of view again, but start

More information

Stability constants for kernel-based interpolation processes

Stability constants for kernel-based interpolation processes Dipartimento di Informatica Università degli Studi di Verona Rapporto di ricerca Research report 59 Stability constants for kernel-based interpolation processes Stefano De Marchi Robert Schaback Dipartimento

More information

Evaluation of Chebyshev pseudospectral methods for third order differential equations

Evaluation of Chebyshev pseudospectral methods for third order differential equations Numerical Algorithms 16 (1997) 255 281 255 Evaluation of Chebyshev pseudospectral methods for third order differential equations Rosemary Renaut a and Yi Su b a Department of Mathematics, Arizona State

More information

D. Shepard, Shepard functions, late 1960s (application, surface modelling)

D. Shepard, Shepard functions, late 1960s (application, surface modelling) Chapter 1 Introduction 1.1 History and Outline Originally, the motivation for the basic meshfree approximation methods (radial basis functions and moving least squares methods) came from applications in

More information

Recent Results for Moving Least Squares Approximation

Recent Results for Moving Least Squares Approximation Recent Results for Moving Least Squares Approximation Gregory E. Fasshauer and Jack G. Zhang Abstract. We describe two experiments recently conducted with the approximate moving least squares (MLS) approximation

More information

A Numerical Study of the Accuracy and Stability of Symmetric and Asymmetric RBF Collocation methods for Hyperbolic PDEs

A Numerical Study of the Accuracy and Stability of Symmetric and Asymmetric RBF Collocation methods for Hyperbolic PDEs A Numerical Study of the Accuracy and Stability of Symmetric and Asymmetric RBF Collocation methods for Hyperbolic PDEs Scott A. Sarra Marshall University May 9, 27 Abstract Differentiation matrices associated

More information

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C.

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C. Lecture 9 Approximations of Laplace s Equation, Finite Element Method Mathématiques appliquées (MATH54-1) B. Dewals, C. Geuzaine V1.2 23/11/218 1 Learning objectives of this lecture Apply the finite difference

More information

Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS

Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS 5.1 Introduction When a physical system depends on more than one variable a general

More information

Radial Basis Function methods - reduced computational expense by exploiting symmetry

Radial Basis Function methods - reduced computational expense by exploiting symmetry Radial Basis Function methods - reduced computational expense by exploiting symmetry Scott A. Sarra Marshall University March 28, 2018 Abstract Radial basis function (RBF) methods are popular methods for

More information

Theoretical and computational aspects of multivariate interpolation with increasingly flat radial basis functions

Theoretical and computational aspects of multivariate interpolation with increasingly flat radial basis functions Theoretical and computational aspects of multivariate interpolation with increasingly flat radial basis functions Elisabeth Larsson Bengt Fornberg June 0, 003 Abstract Multivariate interpolation of smooth

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 7: Conditionally Positive Definite Functions Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH 590 Chapter

More information

A Numerical Solution of the Lax s 7 th -order KdV Equation by Pseudospectral Method and Darvishi s Preconditioning

A Numerical Solution of the Lax s 7 th -order KdV Equation by Pseudospectral Method and Darvishi s Preconditioning Int. J. Contemp. Math. Sciences, Vol. 2, 2007, no. 22, 1097-1106 A Numerical Solution of the Lax s 7 th -order KdV Equation by Pseudospectral Method and Darvishi s Preconditioning M. T. Darvishi a,, S.

More information

Numerical Methods for PDEs

Numerical Methods for PDEs Numerical Methods for PDEs Problems 1. Numerical Differentiation. Find the best approximation to the second drivative d 2 f(x)/dx 2 at x = x you can of a function f(x) using (a) the Taylor series approach

More information

13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs)

13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs) 13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs) A prototypical problem we will discuss in detail is the 1D diffusion equation u t = Du xx < x < l, t > finite-length rod u(x,

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 39: Non-Symmetric RBF Collocation in MATLAB Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH 590 Chapter

More information

STABLE CALCULATION OF GAUSSIAN-BASED RBF-FD STENCILS

STABLE CALCULATION OF GAUSSIAN-BASED RBF-FD STENCILS STABLE CALCULATION OF GAUSSIAN-BASED RBF-FD STENCILS BENGT FORNBERG, ERIK LEHTO, AND COLLIN POWELL Abstract. Traditional finite difference (FD) methods are designed to be exact for low degree polynomials.

More information

The method of lines (MOL) for the diffusion equation

The method of lines (MOL) for the diffusion equation Chapter 1 The method of lines (MOL) for the diffusion equation The method of lines refers to an approximation of one or more partial differential equations with ordinary differential equations in just

More information

arxiv: v1 [math.na] 4 Nov 2015

arxiv: v1 [math.na] 4 Nov 2015 ON WELL-CONDITIONED SPECTRAL COLLOCATION AND SPECTRAL METHODS BY THE INTEGRAL REFORMULATION KUI DU arxiv:529v [mathna 4 Nov 25 Abstract Well-conditioned spectral collocation and spectral methods have recently

More information

Numerical analysis of heat conduction problems on 3D general-shaped domains by means of a RBF Collocation Meshless Method

Numerical analysis of heat conduction problems on 3D general-shaped domains by means of a RBF Collocation Meshless Method Journal of Physics: Conference Series PAPER OPEN ACCESS Numerical analysis of heat conduction problems on 3D general-shaped domains by means of a RBF Collocation Meshless Method To cite this article: R

More information

A Comparison between Solving Two Dimensional Integral Equations by the Traditional Collocation Method and Radial Basis Functions

A Comparison between Solving Two Dimensional Integral Equations by the Traditional Collocation Method and Radial Basis Functions Applied Mathematical Sciences, Vol. 5, 2011, no. 23, 1145-1152 A Comparison between Solving Two Dimensional Integral Equations by the Traditional Collocation Method and Radial Basis Functions Z. Avazzadeh

More information

Simple Examples on Rectangular Domains

Simple Examples on Rectangular Domains 84 Chapter 5 Simple Examples on Rectangular Domains In this chapter we consider simple elliptic boundary value problems in rectangular domains in R 2 or R 3 ; our prototype example is the Poisson equation

More information

Approximation by Conditionally Positive Definite Functions with Finitely Many Centers

Approximation by Conditionally Positive Definite Functions with Finitely Many Centers Approximation by Conditionally Positive Definite Functions with Finitely Many Centers Jungho Yoon Abstract. The theory of interpolation by using conditionally positive definite function provides optimal

More information

Scattered Data Approximation of Noisy Data via Iterated Moving Least Squares

Scattered Data Approximation of Noisy Data via Iterated Moving Least Squares Scattered Data Approximation o Noisy Data via Iterated Moving Least Squares Gregory E. Fasshauer and Jack G. Zhang Abstract. In this paper we ocus on two methods or multivariate approximation problems

More information

Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations

Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations by Wilhelm Heinrichs Universität Duisburg Essen, Ingenieurmathematik Universitätsstr.

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 1 Part 3: Radial Basis Function Interpolation in MATLAB Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2014 fasshauer@iit.edu

More information

Basic Aspects of Discretization

Basic Aspects of Discretization Basic Aspects of Discretization Solution Methods Singularity Methods Panel method and VLM Simple, very powerful, can be used on PC Nonlinear flow effects were excluded Direct numerical Methods (Field Methods)

More information

Introduction to Partial Differential Equations

Introduction to Partial Differential Equations Introduction to Partial Differential Equations Philippe B. Laval KSU Current Semester Philippe B. Laval (KSU) Key Concepts Current Semester 1 / 25 Introduction The purpose of this section is to define

More information

Preliminary Examination in Numerical Analysis

Preliminary Examination in Numerical Analysis Department of Applied Mathematics Preliminary Examination in Numerical Analysis August 7, 06, 0 am pm. Submit solutions to four (and no more) of the following six problems. Show all your work, and justify

More information

Spectral Methods and Inverse Problems

Spectral Methods and Inverse Problems Spectral Methods and Inverse Problems Omid Khanmohamadi Department of Mathematics Florida State University Outline Outline 1 Fourier Spectral Methods Fourier Transforms Trigonometric Polynomial Interpolants

More information

Equations Introduction

Equations Introduction Chapter 9 90 Introduction Partial Differential Equations The numerical treatment of partial differential equations is, by itself, a vast subject Partial differential equations are at the heart of many,

More information

Solving the 3D Laplace Equation by Meshless Collocation via Harmonic Kernels

Solving the 3D Laplace Equation by Meshless Collocation via Harmonic Kernels Solving the 3D Laplace Equation by Meshless Collocation via Harmonic Kernels Y.C. Hon and R. Schaback April 9, Abstract This paper solves the Laplace equation u = on domains Ω R 3 by meshless collocation

More information

Radial basis functions topics in slides

Radial basis functions topics in slides Radial basis functions topics in 40 +1 slides Stefano De Marchi Department of Mathematics Tullio Levi-Civita University of Padova Napoli, 22nd March 2018 Outline 1 From splines to RBF 2 Error estimates,

More information

BOUNDARY-VALUE PROBLEMS IN RECTANGULAR COORDINATES

BOUNDARY-VALUE PROBLEMS IN RECTANGULAR COORDINATES 1 BOUNDARY-VALUE PROBLEMS IN RECTANGULAR COORDINATES 1.1 Separable Partial Differential Equations 1. Classical PDEs and Boundary-Value Problems 1.3 Heat Equation 1.4 Wave Equation 1.5 Laplace s Equation

More information

Spectral Collocation Method for Parabolic Partial Differential Equations with Neumann Boundary Conditions

Spectral Collocation Method for Parabolic Partial Differential Equations with Neumann Boundary Conditions Applied Mathematical Sciences, Vol. 1, 2007, no. 5, 211-218 Spectral Collocation Method for Parabolic Partial Differential Equations with Neumann Boundary Conditions M. Javidi a and A. Golbabai b a Department

More information

Solving Boundary Value Problems (with Gaussians)

Solving Boundary Value Problems (with Gaussians) What is a boundary value problem? Solving Boundary Value Problems (with Gaussians) Definition A differential equation with constraints on the boundary Michael McCourt Division Argonne National Laboratory

More information

Radial basis function partition of unity methods for PDEs

Radial basis function partition of unity methods for PDEs Radial basis function partition of unity methods for PDEs Elisabeth Larsson, Scientific Computing, Uppsala University Credit goes to a number of collaborators Alfa Ali Alison Lina Victor Igor Heryudono

More information

MATH 333: Partial Differential Equations

MATH 333: Partial Differential Equations MATH 333: Partial Differential Equations Problem Set 9, Final version Due Date: Tues., Nov. 29, 2011 Relevant sources: Farlow s book: Lessons 9, 37 39 MacCluer s book: Chapter 3 44 Show that the Poisson

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Discretization of Boundary Conditions Discretization of Boundary Conditions On

More information

A numerical solution of a Kawahara equation by using Multiquadric radial basis function

A numerical solution of a Kawahara equation by using Multiquadric radial basis function Mathematics Scientific Journal Vol. 9, No. 1, (013), 115-15 A numerical solution of a Kawahara equation by using Multiquadric radial basis function M. Zarebnia a, M. Takhti a a Department of Mathematics,

More information

Chapter 1: Systems of linear equations and matrices. Section 1.1: Introduction to systems of linear equations

Chapter 1: Systems of linear equations and matrices. Section 1.1: Introduction to systems of linear equations Chapter 1: Systems of linear equations and matrices Section 1.1: Introduction to systems of linear equations Definition: A linear equation in n variables can be expressed in the form a 1 x 1 + a 2 x 2

More information

Radial Basis Functions I

Radial Basis Functions I Radial Basis Functions I Tom Lyche Centre of Mathematics for Applications, Department of Informatics, University of Oslo November 14, 2008 Today Reformulation of natural cubic spline interpolation Scattered

More information

A RADIAL BASIS FUNCTION METHOD FOR THE SHALLOW WATER EQUATIONS ON A SPHERE

A RADIAL BASIS FUNCTION METHOD FOR THE SHALLOW WATER EQUATIONS ON A SPHERE A RADIAL BASIS FUNCTION METHOD FOR THE SHALLOW WATER EQUATIONS ON A SPHERE NATASHA FLYER AND GRADY B. WRIGHT Abstract. The paper derives the first known numerical shallow water model on the sphere using

More information

8 A pseudo-spectral solution to the Stokes Problem

8 A pseudo-spectral solution to the Stokes Problem 8 A pseudo-spectral solution to the Stokes Problem 8.1 The Method 8.1.1 Generalities We are interested in setting up a pseudo-spectral method for the following Stokes Problem u σu p = f in Ω u = 0 in Ω,

More information

Scattered Data Interpolation with Polynomial Precision and Conditionally Positive Definite Functions

Scattered Data Interpolation with Polynomial Precision and Conditionally Positive Definite Functions Chapter 3 Scattered Data Interpolation with Polynomial Precision and Conditionally Positive Definite Functions 3.1 Scattered Data Interpolation with Polynomial Precision Sometimes the assumption on the

More information

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES)

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) RAYTCHO LAZAROV 1 Notations and Basic Functional Spaces Scalar function in R d, d 1 will be denoted by u,

More information

Toward Approximate Moving Least Squares Approximation with Irregularly Spaced Centers

Toward Approximate Moving Least Squares Approximation with Irregularly Spaced Centers Toward Approximate Moving Least Squares Approximation with Irregularly Spaced Centers Gregory E. Fasshauer Department of Applied Mathematics, Illinois Institute of Technology, Chicago, IL 6066, U.S.A.

More information

AN ELEMENTARY PROOF OF THE OPTIMAL RECOVERY OF THE THIN PLATE SPLINE RADIAL BASIS FUNCTION

AN ELEMENTARY PROOF OF THE OPTIMAL RECOVERY OF THE THIN PLATE SPLINE RADIAL BASIS FUNCTION J. KSIAM Vol.19, No.4, 409 416, 2015 http://dx.doi.org/10.12941/jksiam.2015.19.409 AN ELEMENTARY PROOF OF THE OPTIMAL RECOVERY OF THE THIN PLATE SPLINE RADIAL BASIS FUNCTION MORAN KIM 1 AND CHOHONG MIN

More information

A Meshfree Method for Solving the Monge Ampère Equation Klaus Böhmer 1, Robert Schaback 2

A Meshfree Method for Solving the Monge Ampère Equation Klaus Böhmer 1, Robert Schaback 2 INTRODUCTION A Meshfree Method for Solving the Monge Ampère Equation Klaus Böhmer, Robert Schaback 2 Abstract: This paper solves the two-dimensional Dirichlet problem for the Monge-Ampère equation by a

More information

PART IV Spectral Methods

PART IV Spectral Methods PART IV Spectral Methods Additional References: R. Peyret, Spectral methods for incompressible viscous flow, Springer (2002), B. Mercier, An introduction to the numerical analysis of spectral methods,

More information

Numerical solution of surface PDEs with Radial Basis Functions

Numerical solution of surface PDEs with Radial Basis Functions Numerical solution of surface PDEs with Radial Basis Functions Andriy Sokolov Institut für Angewandte Mathematik (LS3) TU Dortmund andriy.sokolov@math.tu-dortmund.de TU Dortmund June 1, 2017 Outline 1

More information

Cubic spline Numerov type approach for solution of Helmholtz equation

Cubic spline Numerov type approach for solution of Helmholtz equation Journal of Linear and Topological Algebra Vol. 03, No. 01, 2014, 47-54 Cubic spline Numerov type approach for solution of Helmholtz equation J. Rashidinia a, H. S. Shekarabi a and M. Aghamohamadi a a Department

More information

Numerical Analysis of Differential Equations Numerical Solution of Elliptic Boundary Value

Numerical Analysis of Differential Equations Numerical Solution of Elliptic Boundary Value Numerical Analysis of Differential Equations 188 5 Numerical Solution of Elliptic Boundary Value Problems 5 Numerical Solution of Elliptic Boundary Value Problems TU Bergakademie Freiberg, SS 2012 Numerical

More information

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Introduction Deng Li Discretization Methods Chunfang Chen, Danny Thorne, Adam Zornes CS521 Feb.,7, 2006 What do You Stand For? A PDE is a Partial Differential Equation This

More information

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9 Spring 2015 Lecture 9 REVIEW Lecture 8: Direct Methods for solving (linear) algebraic equations Gauss Elimination LU decomposition/factorization Error Analysis for Linear Systems and Condition Numbers

More information

11.3 MATLAB for Partial Differential Equations

11.3 MATLAB for Partial Differential Equations 276 3. Generate the shape functions N (i) j = a (i) j where i =1, 2, 3,..., m and j =1, 2, 3,..., m. + b (i) j x + c(i) j y (11.2.17) 4. Compute the integrals for matrix elements α ij and vector elements

More information

A new class of highly accurate differentiation schemes based on the prolate spheroidal wave functions

A new class of highly accurate differentiation schemes based on the prolate spheroidal wave functions We introduce a new class of numerical differentiation schemes constructed for the efficient solution of time-dependent PDEs that arise in wave phenomena. The schemes are constructed via the prolate spheroidal

More information

Numerical analysis of heat conduction problems on irregular domains by means of a collocation meshless method

Numerical analysis of heat conduction problems on irregular domains by means of a collocation meshless method Journal of Physics: Conference Series PAPER OPEN ACCESS Numerical analysis of heat conduction problems on irregular domains by means of a collocation meshless method To cite this article: R Zamolo and

More information

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 28 PART II Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 29 BOUNDARY VALUE PROBLEMS (I) Solving a TWO

More information

Solving linear systems (6 lectures)

Solving linear systems (6 lectures) Chapter 2 Solving linear systems (6 lectures) 2.1 Solving linear systems: LU factorization (1 lectures) Reference: [Trefethen, Bau III] Lecture 20, 21 How do you solve Ax = b? (2.1.1) In numerical linear

More information

Research Article A Note on the Solutions of the Van der Pol and Duffing Equations Using a Linearisation Method

Research Article A Note on the Solutions of the Van der Pol and Duffing Equations Using a Linearisation Method Mathematical Problems in Engineering Volume 1, Article ID 693453, 1 pages doi:11155/1/693453 Research Article A Note on the Solutions of the Van der Pol and Duffing Equations Using a Linearisation Method

More information

The automatic solution of PDEs using a global spectral method

The automatic solution of PDEs using a global spectral method The automatic solution of PDEs using a global spectral method 2014 CBMS-NSF Conference, 29th June 2014 Alex Townsend PhD student University of Oxford (with Sheehan Olver) Supervised by Nick Trefethen,

More information

Preliminary Examination, Numerical Analysis, August 2016

Preliminary Examination, Numerical Analysis, August 2016 Preliminary Examination, Numerical Analysis, August 2016 Instructions: This exam is closed books and notes. The time allowed is three hours and you need to work on any three out of questions 1-4 and any

More information

On Multivariate Newton Interpolation at Discrete Leja Points

On Multivariate Newton Interpolation at Discrete Leja Points On Multivariate Newton Interpolation at Discrete Leja Points L. Bos 1, S. De Marchi 2, A. Sommariva 2, M. Vianello 2 September 25, 2011 Abstract The basic LU factorization with row pivoting, applied to

More information

Introduction - Motivation. Many phenomena (physical, chemical, biological, etc.) are model by differential equations. f f(x + h) f(x) (x) = lim

Introduction - Motivation. Many phenomena (physical, chemical, biological, etc.) are model by differential equations. f f(x + h) f(x) (x) = lim Introduction - Motivation Many phenomena (physical, chemical, biological, etc.) are model by differential equations. Recall the definition of the derivative of f(x) f f(x + h) f(x) (x) = lim. h 0 h Its

More information

COMPARISON OF FINITE DIFFERENCE- AND PSEUDOSPECTRAL METHODS FOR CONVECTIVE FLOW OVER A SPHERE

COMPARISON OF FINITE DIFFERENCE- AND PSEUDOSPECTRAL METHODS FOR CONVECTIVE FLOW OVER A SPHERE COMPARISON OF FINITE DIFFERENCE- AND PSEUDOSPECTRAL METHODS FOR CONVECTIVE FLOW OVER A SPHERE BENGT FORNBERG and DAVID MERRILL Abstract. For modeling convective flows over a sphere or within a spherical

More information

National Taiwan University

National Taiwan University National Taiwan University Meshless Methods for Scientific Computing (Advisor: C.S. Chen, D.L. oung) Final Project Department: Mechanical Engineering Student: Kai-Nung Cheng SID: D9956 Date: Jan. 8 The

More information

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs Chapter Two: Numerical Methods for Elliptic PDEs Finite Difference Methods for Elliptic PDEs.. Finite difference scheme. We consider a simple example u := subject to Dirichlet boundary conditions ( ) u

More information

APPENDIX A. Background Mathematics. A.1 Linear Algebra. Vector algebra. Let x denote the n-dimensional column vector with components x 1 x 2.

APPENDIX A. Background Mathematics. A.1 Linear Algebra. Vector algebra. Let x denote the n-dimensional column vector with components x 1 x 2. APPENDIX A Background Mathematics A. Linear Algebra A.. Vector algebra Let x denote the n-dimensional column vector with components 0 x x 2 B C @. A x n Definition 6 (scalar product). The scalar product

More information

AM 205: lecture 14. Last time: Boundary value problems Today: Numerical solution of PDEs

AM 205: lecture 14. Last time: Boundary value problems Today: Numerical solution of PDEs AM 205: lecture 14 Last time: Boundary value problems Today: Numerical solution of PDEs ODE BVPs A more general approach is to formulate a coupled system of equations for the BVP based on a finite difference

More information

A Simple Compact Fourth-Order Poisson Solver on Polar Geometry

A Simple Compact Fourth-Order Poisson Solver on Polar Geometry Journal of Computational Physics 182, 337 345 (2002) doi:10.1006/jcph.2002.7172 A Simple Compact Fourth-Order Poisson Solver on Polar Geometry Ming-Chih Lai Department of Applied Mathematics, National

More information

Math 7824 Spring 2010 Numerical solution of partial differential equations Classroom notes and homework

Math 7824 Spring 2010 Numerical solution of partial differential equations Classroom notes and homework Math 7824 Spring 2010 Numerical solution of partial differential equations Classroom notes and homework Jan Mandel University of Colorado Denver May 12, 2010 1/20/09: Sec. 1.1, 1.2. Hw 1 due 1/27: problems

More information

Chapter 2 Interpolation

Chapter 2 Interpolation Chapter 2 Interpolation Experiments usually produce a discrete set of data points (x i, f i ) which represent the value of a function f (x) for a finite set of arguments {x 0...x n }. If additional data

More information