Solving Negative Order Equations by the Multigrid Method Via Variable Substitution

Size: px
Start display at page:

Download "Solving Negative Order Equations by the Multigrid Method Via Variable Substitution"

Transcription

1 J Sci Comput (214) 59: DOI 1.17/s Solving Negative Order Equations by the Multigrid Method Via Variable Substitution George C. Hsiao Liwei Xu Shangyou Zhang Received: 26 December 212 / Revised: 12 July 213 / Accepted: 26 July 213 / Published online: 11 August 213 Springer Science+Business Media New York 213 Abstract Variable substitutions are introduced to the single layer potential equations such that the order of pseudo-differential operator is changed from minus one to plus one. Though the condition number remains the same order after such a variable substitution, the frequencies of higher and lower eigenfunctions are switched. The multigrid iteration is shown to be an optimal order solver for the resulting linear systems of boundary element equations. Two types of variable substitutions are suggested. Numerical tests are presented showing efficiency of both methods, and supporting the theory. Keywords Boundary element Single layer potential First kind integral equation Negative order pseudo-differential operator Multigrid method Mathematics Subject Classification 65N3 65N38 1 Introduction The multigrid method provides an optimal order solver for large linear systems arising from discretizing partial differential equations (cf. [1] and references in [3]). The multigrid method G. C. Hsiao S. Zhang (B) Department of Mathematical Sciences, University of Delaware, Newark, DE 19716, USA szhang@udel.edu G. C. Hsiao hsiao@math.udel.edu L. Xu College of Mathematics and Statistics, Chongqing University, Chongqing 41331, People s Republic of China L. Xu Institute of Scientific and Engineering Computing, Chongqing University, Chongqing 444, People s Republic of China xul@cqu.edu.cn

2 372 J Sci Comput (214) 59: is based on two principles. One is to reduce oscillatory, high frequency components of the iterative error by fine-level smoothings. This is in common for all iterative methods, which are all based on the residual correction, as the high frequency error generates larger residue (in positive order differential equations). The other principle, the key principle of multigrid method, is to reduce the smooth, low frequency components of the error by the coarselevel correction, with the optimal order of computation. However, the multigrid method works only for the positive order elliptic equations. In the pseudo-differential equations of negative orders, the eigenfunctions associated with large eigenvalues are smooth while the eigenfunctions for small eigenvalues are oscillatory. The slow convergent component (high oscillatory) of iterative error can not be corrected by the coarse level solutions. Therefore both the fine-level relaxation and the coarse-level correction could not reduce effectively such low eigenvalue components. Bramble et al. proposed a multigrid method in [3]whereH 1 equivalent, discrete innerproducts are introduced to the fine-level relaxation. It changes the relationship between eigenvalues and eigenvectors of the fine-level smoothing operator such that highly oscillatory components of error can be reduced rapidly. They showed that the multigrid method can converge in a rate independent of the size of the linear system to be solved. However, each evaluation of an H 1 discrete inner-product requires essentially a solution of the Laplace equation (preconditioning the equation under consideration), though the latter can be obtained by an optimal order of computation by the multigrid method. In this paper, we solve boundary element equations of negative order one, arising from exterior boundary value problems, for example, an exterior Dirichlet boundary value problem for the Laplacian in R 2 or R 3, shown in Fig. 1. The condition number for the simple-layer boundary operator is O(h 1 ) (cf. [6]) which is studied in Bramble et al. [3]. However, it is not clear how to construct and to evaluate the H 1 discrete inner-product on the boundary. If the boundary is not smooth, for example, with corners, the surface Laplace equation may not be well defined. Even if the boundary is smooth, solving a surface Laplace equation might be more challenging than solving a surface integral equation itself. Therefore, we seek a different approach in the multigrid method. Instead of changing the order of eigenfunctions in the fine-level relaxation as in [3], we change the order of the differential equation from minus one to plus one, by variable substitutions. For the model problem (2.1) shown in Fig. 1, after introducing the fundamental solution, it is converted to the following weak variational problem: Find σ H, such that V σ, χ = f,χ χ H, (1.1) where f := f /2 + Kf, H, V, K are defined in (2.7), (2.5) and(2.4), respectively, and the unkonwn dnsity function σ = u + / n, the normal derivative of u with respect to the unit normal n shown in Fig. 1. We propose two types of variable substitutions for the unknown density function σ of the single layer potential Eq. (1.1): σ = ẇ in 2D, (1.2) σ = W w in 2D and 3D, (1.3) Fig. 1 An exterior boundary value problem

3 J Sci Comput (214) 59: where w is an unknown function on,andẇ denotes the tangential derivative along a boundary curve, and W is the hypersingular operator to be defined in (2.14). The first substitution works only for 2D boundary value problems, while the second works for both 2D and 3D problems. We then discretize the positive order equations by continuous boundary elements: Find w h H h (defined by (2.15)), such that or, in the second method, V ẇ h, v h = f, v h v h H h, (1.4) VWw h, W v h = f, W v h v h H h. (1.5) We show that the standard multigrid method solves Eqs. (1.4) and(1.5) in optimal order of computation, i.e., obtaining an N-dimensional iterative solution up to the truncation error by an order N computation, [1]. Basically, it only requires to show the convergence rate of the multigrid method is constant, independent of the grid size h, or the size N of the linear system to be solved. In the first case, we show the discrete solution obtained by solving (1.4) is exactly the solution of original boundary integral equation: σ h = ẇ h, where σ h is the solution of (2.12). But in the second case, (the conclusion here may depend on the implementation methods,) we obtain another discrete solution in a different function space, σ h = W k w h σ h. It is not clear how to choose numerical quadratures for (1.5), so that the new solution w h would produce the same solution σ h = W w h of (1.5), either at the continuous level, or at the discrete level. We choose a specific numerical integration method in computing (1.5). The discrete solution W k w h converges at the third order, one order higher than the optimal order h 2 of the piecewise constant function space. In our computation, we made w h H h, the space of continuous linear functions on the dual grid. But the optimal order is still O(h 2 ) in L 2 -norm for the piecewise constant function σ h = W h w h. We get a super-convergence (numerically only for four examples) in the second method. The second variable substitution method proposes a new discretization method. The super-convergence analysis of the method is to be done in another paper while this work is limited to the multigrid convergence of the method. In practice, we recommend the first method in 2D, (1.4), where with almost no additional cost, the computation is brought down from O(h 2 log h) to the optimal order O(h 1 log h) (assuming a fast evaluation method such as FFT is used for the bilinear form). But in 3D, we are limited to the second variable substitution method, (1.5). The rest paper is organized as follows. In Sect. 2, we introduce the problem, a boundary element discretization, and variable substitutions. In Sect. 3, we show the constant rate of convergence for the multigrid method when solving the substituted equations. In Sect. 4, we show that the solutions of the original negative one order equation and of the substituted positive one order equation are same, for the d/ds substitution. In Sect. 5, we present some numerical results for W substitution.

4 374 J Sci Comput (214) 59: Variable Substitution We consider the following model exterior Dirichlet problem (cf. Fig. 1) in2dor3d: u = in c := R d \, u = f on :=, u = O(1) or O( x 1 ) as x (2.1) depending on the dimension d = 2or3,where f H 1/2 ( ) is a given function. Here is assumed to be a smooth domain, but we assume there is no curve approximation error and no quadrature error. We use the standard Sobolev space notations (cf. [4,7]). By the Green s formula, we begin with the representation of the solution of (2.1) inthe form: u(x) = u + (y) γ (x, y) ds y n y γ(x, y) u+ n y (y) ds y + c (2.2) for all x c,wherec = in 3D, or in 2D c is an unknown constant depending on f and the boundary shape of in the boundary condition of (2.1), and n is the normal vector to. In 2D, the constant c will be computed by (2.8) below, after u + / n is computed. Here the fundamental solution of the Laplacian is defined by { ( 1/2π)log x y if d = 2, γ(x, y) = 1/(4π x y ) if d = 3. Let x approach from outside, i.e., u(x) = f (x) on. It follows that 1 2 f (x) = f (y) γ (x, y) ds y γ(x, y) u+ (y) ds y + c x, n y n y and that u + (y) n y ds y = in 2D. Representing u + / n by σ, the above equation is, ( ) 1 V σ c = 2 I K f on, (2.3) where K v(x) = γ(x, y)v(y) ds y n y v H 1/2 (), (2.4) V σ(x) = γ(x, y)σ (y) ds y σ H 1/2 (), (2.5) and σ is required to satisfy the condition σ ds =, (2.6)

5 J Sci Comput (214) 59: in the case of d = 2. In order to simplify the presentation, in the following let us denote the space { H 1/2 () in 3D, H = H 1/2 () ={χ H 1/2 (2.7) () 1,χ =} in 2D, and introduce the notation v, χ = vχ ds v H 1/2 (), χ H. Multiplying the Eq. (2.3) by the test functions χ, we get a variational problem for (2.1), i.e., V σ, χ = f,χ χ H, where f = ( 2 1 I K ) f. In the case of d = 2, the unknown constant c in the solution (2.2) is determined by c = (V σ + ((1/2)I K ) f )ds ds. (2.8) In this paper, we confine our presentation in 2D. To define boundary element spaces, we first subdivide the boundary ={y(s) s S(arc length)} into a quasi-uniform segments of curves, to obtain an initial grid 1 ={E 1, j ={y(s) s j 1 s s j }, j = 1, 2,...,N 1 }. (2.9) The multigrids { k } on are defined sequentially by cutting previous elements into halves: k ={E k, j E k 1, j = E k,2 j 1 E k,2 j, E k 1, j k 1 }. (2.1) Let h k be the mesh size of k, h k = max E k, j, 1 j N k where N k = N 1 2 k 1,and E k, j is the arc length of curve E k, j. We note that h k = h k 1 /2. Let the boundary element spaces be the piecewise constant spaces on the multigrids k, S hk ={v H 1/2 () v Ek, j P, j = 1, 2,...N k }. (2.11) We note that dim S hk = N k 1. The boundary element discretization for the single layer potential equation can be formulated: Find σ hk S hk such that V σ hk,χ = f,χ χ S hk. (2.12) Let {φ j } be nodal basis functions of S hk, i.e., φ j = 1onE k, j but on rest elements of k. The problem (2.12) can be written in a matrix form, B k σ hk = f hk (2.13)

6 376 J Sci Comput (214) 59: Table 1 The errors and the iteration numbers, for (2.12) with (2.17) k σ σ hk L 2 h n k #jc σ σ hk L 2 h n k #jc C(B k ) a = 1in(2.17) a = 1.9in(2.17) , , Fig. 2 Eigenvectors v 2 (for smallest eigenvalue) and v Nk,cf.(2.18) where the entries of matrix B k, vectors σ hk and f hk are defined respectively, by (B k ) i, j = Vφ j,φ i, ( σ hk ) j = c j so that σ hk = c j φ j, 1 j N k ( f hk ) j = f,φ j. When solving the linear system of Eq. (2.13), the rate of convergence of the iterative solution depends on the condition number of B k, for the usual iterative methods such as the conjugate gradient method or the Jacobi method. The condition number of B k is of O(h 1 k ), as shown numerically in Table 1. The standard multigrid method would not accelerate these iterations either, as the slow convergence component of the iterate is highly oscillatory, which can not be approximated by the coarse level solutions. We can see this in Fig. 2 which is obtained from (2.18). Next, we introduce variable substitutions by (1.2)and(1.3), i.e., σ = ẇ = d w, σ = W w. ds Here W is a hypersingular operator defined by W w(x) = γ (x, y)w(y)ds y, x. (2.14) n x n y

7 J Sci Comput (214) 59: Fig. 3 The solution σ hk for (2.12) with a = 1.9in(2.17) We next introduce the boundary element spaces, H hk ={v H 1/2 () C () v Ek, j P 1 E k, j k }, (2.15) consisting of continuous, piecewise linear functions on grid k. We note that for v H hk,v Ek, j is a linear function of arc length, i.e, it is a linear function on the reference element. On E k, j, its graph is a space curve, not on a plane. The two spaces S hk and H hk are of the same dimension, dim H hk = dim S hk = N k 1. Let {ψ j } be nodal basis function of H hk. Then we represent both linear systems for (1.4)and (1.5)by A k w hk =ḡ hk, (2.16) where the matrix and vectors are defined respectively, by (A k ) i, j = V ψ j, ψ i or VWψ j, W ψ i, N k ( w hk ) j = w j so that w j ψ j = w hk, j=1 (ḡ hk ) j = f, ψ j or f, W ψ j. We will discuss the multigrid method for solving the substituted Eq. (2.16)in the next section. To conclude this section, we show the necessity of variable substitution for the multigrid method, by using a simple numerical example. Let be the circle of radius 8 centered at the origin. Let the exact solution of (2.1)be u = log (x a)2 + (y a) 2 (x a) 2, a < 2. (2.17) + (y + a) 2 Now let be cut by the four points (±2, ±2) to be the initial grid 1. We solve the discretized problem (2.12) by the Jacobi iteration. In Table 1, we list the errors in L 2 norm of solutions σ hk, the convergence order, and the number of Jacobi iterations used to solve the boundary element equations with a = 1and1.9 in(2.17). We note that when a 2, the solution in (2.17) is nearly singular. The solution σ hk when a = 1.9 is plotted in Fig. 3.

8 378 J Sci Comput (214) 59: In Table 1, #jc stands for the number of Jacobi iterations. We also list in Table 1 the condition number C(B k ) of matrices B k in (2.13). We note that the first eigenvalue of B k is negative, whose associated eigenvectors are a global constant, which is not in the function space S hk. The rest eigenvalues are positive, numbered by Numerically, we have B k v j = λ k, j v j, <λ k,2 λ k,3 λ k,nk. (2.18) λ k,2 h k, λ k,nk 1. But the eigenvector v 2 is oscillatory, while v Nk is smooth, shown in Fig. 2. The (effective) condition number of B k is defined by C(B k ) = λ k,n k λ k,2 = O(h 1 k ). The numerical values of the condition number C(B k ) are listed in the last column of Table 1. 3 The Multigrid Method We define a standard multigrid method for solving the positive order boundary element Eq. (2.16). We represent both variable substitutions by the form Aw, v = Vẇ, v or VWw, W v w, v H 1/2. (3.1) We may simply write the derived operator A as A = d ds V d ds or WVW. We note that W is symmetric. We remark that (cf. [7,8]) V μ, ν = Wμ, ν μ, ν H 1/2 (). Now, as W : H 1/2 () H 1/2 () is a pseudo-differential operator of order plus one, for both cases in (3.1), the operator A is a pseudo-differential operator of order plus one: A : H 1/2 () H 1/2 (). For analyzing the multigrid method, we introduce the usual discrete norms on the discrete spaces H hk (cf. [1]): w hk k, s = A 2s k w h k,w hk, w hk H hk, s 1. (3.2) Here the symmetric positive-definite operator A k (also used to denote the discrete matrix in (2.16)) is a restriction of A (3.1) on the boundary element spaces: A k : H hk S hk, A k w hk,v hk = Aw hk,v hk w hk,v hk H hk. Similar to [1], we define a multigrid method (recursively) for solving the linear systems (2.16):

9 J Sci Comput (214) 59: Definition 3.1 (A multigrid method) Given an initial w approximating the solution w hk in (2.16), one k th level multigrid iteration produces a new approximation w m+1 as follows. First, m Richardson smoothings are performed: w l = w l 1 + ρ(a k ) 1 (ḡ k A k w l 1 ) l = 1,...,m, (3.3) where ρ(a k ) stands for the spectral radius of the symmetric positive-definite matrix A k or an upper bound of it. As in (2.16), w denotes the coefficient vector of function w H hk. Then we solve the residual problem on the coarse level A k 1 q,v hk 1 = g k A k w m,v hk 1 v hk 1 H hk 1. (3.4) by doing p( 1)(k 1) st level multigrid iterations to get a solution q,ifk > 1. If k = 1 we solve (3.4) exactly to get q = q. Finally w m+1 = w m + q. (3.5) We note that there is an interpolation operator I k : H hk 1 H hk in the residual Eq. (3.4) and in the coarse level correction (3.5). But as the multi-level spaces are nested, H hk 1 H hk, I k is the identity operator, or natural embedding, I k v hk 1 = v hk 1. But computationally, I k is needed for transferring functions from one grid to the next. Lemma 3.1 The discrete norms are bounded by the fractional order Sobolev norms: for any v hk H hk, Proof First, we have, cf. [7], v hk k,s C v hk H s, s 1 2. (3.6) v H 1/2 W v, v v H 1/2 (). Here we use a notation A B for an equivalence, i.e., C 1 A B C 2 A for some positive constants C 1 and C 2. For any v hk H hk, we have two definitions of the discrete norm, depending on the variable substitution method. For the first case, A k = ds d V ds d,foranyv h k H hk,wehave v hk H 1/2 W v hk,v hk = V v hk, v hk = A k v hk,v hk = v hk k,1/2. For the second case, A k = WVW, we need also to use another norm equivalence: For any v hk H hk,wehave For both cases, we have σ H 1/2 V σ, σ. v hk H 1/2 W v hk,v hk = W 1/2 v hk L 2 W v hk H 1/2 VWv hk, W v hk = A k v hk,v hk = v hk k,1/2. v hk H 1/2 C v hk k,1/2 v hk H = v hk k, = v hk,v hk. Thus, (3.6) is obtained by the interpolation, cf. [4].

10 38 J Sci Comput (214) 59: Lemma 3.2 The following smoothing property holds for (3.3): e m k,1/2+α Cm α h α k e k,1/2, <α 1 2 (3.7) where the iterative errors are denoted by e l = w hk w l. Proof The proof is similar to that for the second order differential operator [1]. Here we have a first order pseudo differential operator. Let A k have the following (orthonormal) eigen expansion: A k v j = λ k, j v j, <λ k,2 λ k,nk. Here {v j } forms an orthogonal basis for H hk products. Let e be expanded under the basis with respect to both, and A, inner N k e = c j v j. j=2 By (3.3), Thus, N k ( e m = (I ρ(a k ) 1 A k ) m e = 1 λ ) m k, j c j v j. λ k,nk j=2 j=2 N k e m 2 k,1/2+α = ( 1 λ ) 2m k, j c 2 j λ λ1+2α k, j k,nk ( max (1 x [,1] x)2m x 2α ) λ 2α k,n k N k j=2 c 2 j λ1 k, j = Cm 2α ρ(a k ) 2α e 2 k,1/2 Cm 2α h 2α k e 2 k,1/2, where we have used the standard inverse inequality for estimating ρ(a k ), i.e., ρ(a k ) Ch 1 k. This completes the proof. Theorem 3.1 (Constant-rate convergence for MG) For any positive γ<1, there exist constants m (large enough) and p(> 1), both independent of k, such that Here w hk and w i are defined in Definition 3.1. w hk w m+1 k,1/2 γ w hk w k,1/2. (3.8) Proof We will prove the convergence of two-level multigrid method (i.e., q = q in (3.5)). By which it is standard to show the W-cycle (p > 1) convergence (cf. [1]). The proof here is similartothatin[1], except the notations and the order of the pseudo-differential operator. Let the iterative errors be denoted by e l = w hk w l H hk.

11 J Sci Comput (214) 59: Noticing the orthogonal projection property of the coarse-level correction (3.4), (3.5), we have e m+1 2 k,1/2 = A k(e m q), e m e m+1 k,1/2 α e m k,1/2+α, (3.9) where <α 1/2isthe order of regularity for the boundary value problem (2.1) inthe following sense. For any Dirichlet data f H 1/2+α () in (1.1), there is a unique solution σ H 1/2+α () in (1.1) such that σ H 1/2+α () C f H 1/2+α (). (3.1) This regularity result is a direct consequence of the elliptic regularity for the original boundary value problem (1.1) after applying the Sobolev trace theorem, cf. [7,8]. We next apply a duality argument to the first term of (3.9). For any g H 1/2+α () with g H α+1/2 () = 1, let σ g be the solution of (1.1) with f there being replaced by g. Wethen let u g be a density function of σ g, i.e., σ g = u g in the first case of (3.1), or σ g = Wu g in the second case. By the equivalence of norms in (3.6), the regularity assumption (3.1) andthe standard approximation properties of boundary elements, we get e m+1 k,1/2 α C e m+1 H 1/2 α () = C ė m+1 H 1/2 α () = C sup g H 1/2+α () =1 ė m+1, g =C sup ė m+1, V σ g g = C sup ė m+1, V u g =Csup A(e m q), u g g g C sup e m q H 1/2 u g I k 1 u g H 1/2 g C e m q k,1/2 sup h α k 1 u g H 1/2+α () g = C e m q k,1/2 sup h α k 1 σ g H 1/2+α () g = C e m q k,1/2 sup h α k 1 g H 1/2+α () g = Ch α k 1 e m+1 k,1/2. (3.11) Here I k 1 is the standard nodal interpolation operator onto H hk. As we assume α>, I k 1 is well defined in 2D. But in 3D, as well as in 2D, it can be replaced by an averaging interpolation operator, Scott-Zhang operator [1]. We remark that for s = and 1/2, (3.6) can be reversed, i.e, v hk H 1/2 C v hk k,1/2. But it is not clear for middle s (though it is widely used). The proof for the second case of (3.1) is same except replacing the dot operator in (3.11)bythe W operator. Therefore, combining (3.9), (3.7) and(3.11), (3.8) is shown when m is chosen large enough such that Cm α γ. 4Thed/ds Substitution When we make two variable substitutions in (3.1), the original PDE solutions are exactly the same as that obtained from the two potential solutions: Au,v = f, v or f, W v, v H 1/2 (). That is, σ = u or σ = Wu.

12 382 J Sci Comput (214) 59: But at the discrete level, it is not clear what is the relationship between σ hk of (2.12)andw hk of (2.16). This is to be studied in this section and next, for the two cases. Proposition 4.1 The solution of (2.12) is the tangential derivative of the solution of (2.16), σ hk = ẇ h,k, when A = ds d V ds d, i.e., w h k H hk such that V ẇ hk, v = f, v v H hk. (4.1) d Proof ds is an one-one on-to mapping from H h k to S hk. Equation (4.1) implies V ẇ hk,χ = Vf,χ χ S hk. Its unique solution is then σ hk of (2.12). We note that there is no numerical (truncation) error when computing ẇ hk as the function is a linear function of arc length on each curve segment. In computation, we evaluate Aw hk,v by V ẇ hk, v. There is no numerical error/difference between solving the original Eq. (2.12) and solving the substituted Eq. (4.1). But this may not be true for our second variable substitution, to be studied next section. Theorem 4.1 (Optimal order of computation) By an order O(N hk ) of computation, the multigrid solution w hk ( w hk ) of (4.1) approximates the true solution σ of (1.1) at the optimal order: σ w hk L 2 () Ch 2 f H 1 (). Proof By (3.8) and by choosing the previous level solution as the initial guess, the multigrid method would produce a solution w hk up to the truncation error by a constant number of iterations (independent of the size of the linear systems of equations). This is called an optimal order of computation of the multigrid method, cf. [1]. Then we assume the boundary has some local symmetry so that the matrix B k in (2.13) is locally cyclic. If so, B k σ k can be evaluated in O(N hk ) or O(N hk log N hk ) computation, via the fast Fourier transform method on B k or on its submatrices, cf. [14]. The fast multipole method may also provide an evaluation of A k w hk by order N k operations, [5]. The total work for the multigrid method would be of O(N hk ). We end this section by a numerical test on the multigrid method with d/ds variable substitution. We solve (4.1) with the exact solution from (2.17) with a = 1. The errors by the variable substitution method are listed in the second column of Table 2, which are exactly thesameasthatintable1. This is shown in Proposition 4.1. The linear systems of Eq. (4.1) are solved by three methods, the Richardson iteration (3.3), the conjugate gradient method, and the multigrid method. The number of iteration is listed in Table 2, for all three methods. As the condition number of A k is of order h 1 k, we need O(2 k ) Richardson iterations, O( 2 k ) conjugate gradient iterations, but O(1) multigrid iterations (shown in Theorem 3.1). In our computation, we use the V-cycle multigrid method with four fine-level smoothings, i.e., p = 1andm = 4 in Definition 3.1. Here the computation is done on a Toshiba Satellite A135-S4656 laptop with a 1.6GHz Intel Celeron M Processor 52 and a memory of 512MB. We listed the computation time for each computation in Table 2. The growth rate of computation time for the multigrid method is 4, instead of 2, predicted by Theorem 4.1. This is because we did not use the fast Fourier transform to evaluate A k w hk, which costs us O(N 2 k ) operations instead of O(N k) operations. Also we can use the fast multipole method to evaluate A k w hk,byanordern k operations, [5].

13 J Sci Comput (214) 59: Table 2 The errors, iterations, and CPU time, for (4.1) with (2.17) k σ w hk L 2 h n k #jc cpu #cg cpu #mg cpu , , ,916 2, TheW Substitution The substitution method σ hk = ẇ hk works well in 2D. But it cannot be extended to 3D. The other substitution method σ hk = W w hk would work in both 2D and 3D. Our early analysis remains the same in 3D. However, computationally, it is not fully clear yet how to implement the method: Find w hk H hk such that VWw hk, W v hk = f, W v hk v hk H hk. (5.1) The central problem is on the evaluation of hypersingular operator W, especially in 3D. There are many methods, but all are complicated, cf. [11] and references therein. In our computation, we use the 2D formula W w, v = Vẇ, v w, v H 1/2 (). This way, the hypersingular operator is evaluated via a weakly singular operator. This is a widely used approach. Therefore, the cost of evaluating a matrix vector product A k w in the W substitution method is about three times of that A k w evaluationinthed/ds substitution method. But there is still another problem, finding appropriate quadrature formulas for (5.1). To evaluate V ẇ hk accurately, when ẇ hk has a jump at each grid points, we introduce a dual grid space. In other words, it is natural and accurate numerically, to find the mapping V : S hk H 1/2 () H hk H 1/2 (), where H hk is defined the same way as H hk butonadualgrid k of k. That is, the grid points of k are the mid-points of elements of k. This is perfect for evaluating, in our last method of ẇ-substitution, V ẇ hk, v hk w hk,v hk H hk, where one mid-point quadrature formula is used for the boundary integral. At a middle point, ẇ hk is continuous. Therefore, we introduce an approximation of W operator: W k : H hk S hk, (5.2) W k w hk,v hk = V k ẇ hk, v hk, (5.3)

14 384 J Sci Comput (214) 59: Table 3 The errors, iterations, and CPU time, for (5.1) with a = 1in(2.17) k I k σ W w hk L 2 h n k #cg cpu #mg cpu where V k : S hk H hk, (5.4) V k v hk Ek, j = (V v hk )(x k, j ) E k, j k. (5.5) In (5.5), x k, j is the middle point of a curve segment E k, j. By this method, we change the Eq. (5.1)to V k W k w hk, W k ṽ hk = f, W k v hk v hk H hk. (5.6) In Table 3, we list the error and the number of iterations when solving the linear system (5.1) with exact solution (2.17) with a = 1. Because the coarse level solution of the residual problem (3.4) is no longer an projection of the iterative error, we have a nonnested multigrid method, due to the perturbation of W k to W in (5.3). The convergence of nonnested multigrid methods is not guaranteed, cf. [2,12,13,15]. Extra steps of fine-level smoothings (3.3) are needed to suppress the nonnested error from the coarse level correction. Here, we change the Richardson iteration (3.3) in the multigrid method (Definition 3.1) to the conjugate gradient iteration. We note that the conjugate gradient iteration reduces errors of all frequencies. Here we use V-cycle multigrid method with eight smoothings, (p = 1andm = 8 in Definition 3.1). This barely makes the nonnested multigrid method converge. From the CPU time used in Table 3, this time the multigrid method does not beat the conjugate gradient method yet (cf. Table 2). Of course, when the level is low, i.e., for small linear systems, the conjugate gradient method would be always faster than the multigrid method (of optimal order). In 2D, the second substitution, the W substitution, seems much worse than the d/ds substitution, from the computational cost. However, numerically, we found a superconvergence for the W substitution. In Table 3, we can see that the order of convergence is 3, one order higher than the optimal order, 2. Where in Table 3 I k stands for the mid-point interpolation operator from H 1 () to S hk. We do not have a proof for this phenomenon yet. We further tested a few cases, i.e., the exact u in (2.1)is: 3 ( ) r ni u(r,θ) = cos(n i θ), (5.7) 8 i=1 u(x, y) = e x sin y (an interior solution.) (5.8)

15 J Sci Comput (214) 59: Table 4 The error e k = I k σ W w hk of (5.1) with various exact solutions k e k L 2 h n k e k L 2 h n k e k L 2 h n k (2.17), a = 1.5 (5.7), n i = 3, 7, 11 (5.8) In all cases we tested, we get a third order convergence. Three more test results are listed in Table 4. Again, the convergence of the W -substitution method (due to numerical integration methods) is one order higher than that of standard boundary element method (cf. Table 2). Acknowledgments Liwei Xu is partially supported by the Youth 1 Plan start-up grant of Chongqing University (No ) in China. References 1. Bank, R., Dupont, T.: An optimal order process for solving finite element equations. Math. Comput. 36(153), (1981) 2. Bramble, J.H., Pasciak, J.E., Xu, J.: The analysis of multigrid algorithms for nonsymmetric and indefinite elliptic problems. Math. Comput. 51(184), (1988) 3. Bramble, J.H., Leyk, Z., Pasciak, J.E.: The analysis of multigrid algorithms for pseudodifferential operators of order minus one. Math. Comput. 63(28), (1994) 4. Brenner, S.C., Scott, L.R.: The Mathematical Theory of Finite Element Methods. Springer, New York (1994) 5. Greengard, L., Rokhlin, V.: A fast algorithm for particle simulations. J. Comput. Phys. 73(2), (1987) 6. Hsiao, G.C., Wendland, Q.L.: Boundary Element Method: Foundation and Error Analysis. Chapter 12 in Encyclopedia of Computational Mechanics, edited by Erwin Stein et al. vol. 1, Wiley (24) 7. Hsiao, G.C., Wendland, W.L.: Boundary Integral Equations. Applied Mathematical Sciences, 164. Springer, Berlin (28) 8. Hsiao, G.C.: On boundary integral equations of the first kind. J. Comput. Math. 7, (1989) 9. Hsiao, G.C., Zhang, S.: Optimal order multigrid methods for solving exterior boundary value problems. SIAM J. Numer. Anal. 31(3), (1994) 1. Scott, L.R., Zhang, S.: Finite element interpolation of nonsmooth functions satisfying boundary conditions. Math. Comput. 54(19), (199) 11. Yu, D.H.: Natural Boundary Integral Method and Its Applications. Translated from the 1993 Chinese Original. Mathematics and its Applications, 539. Kluwer, Dordrecht; Science Press, Beijing (22) 12. Zhang, S.: Optimal-order nonnested multigrid methods for solving finite element equations. I. On quasiuniform meshes. Math. Comput. 55(191), (199) 13. Zhang, S.: Optimal-order nonnested multigrid methods for solving finite element equations. II. On nonquasiuniform meshes. Math. Comput. 55(192), (199) 14. Zhang, S.: On the convergence of spectral multigrid methods for solving periodic problems. Calcolo 28(3 4), (1991) 15. Zhang, S.: Optimal-order nonnested multigrid methods for solving finite element equations. III. On degenerate meshes. Math. Comput. 64(29), (1995)

High order, finite volume method, flux conservation, finite element method

High order, finite volume method, flux conservation, finite element method FLUX-CONSERVING FINITE ELEMENT METHODS SHANGYOU ZHANG, ZHIMIN ZHANG, AND QINGSONG ZOU Abstract. We analyze the flux conservation property of the finite element method. It is shown that the finite element

More information

A MULTIGRID ALGORITHM FOR. Richard E. Ewing and Jian Shen. Institute for Scientic Computation. Texas A&M University. College Station, Texas SUMMARY

A MULTIGRID ALGORITHM FOR. Richard E. Ewing and Jian Shen. Institute for Scientic Computation. Texas A&M University. College Station, Texas SUMMARY A MULTIGRID ALGORITHM FOR THE CELL-CENTERED FINITE DIFFERENCE SCHEME Richard E. Ewing and Jian Shen Institute for Scientic Computation Texas A&M University College Station, Texas SUMMARY In this article,

More information

INTERGRID OPERATORS FOR THE CELL CENTERED FINITE DIFFERENCE MULTIGRID ALGORITHM ON RECTANGULAR GRIDS. 1. Introduction

INTERGRID OPERATORS FOR THE CELL CENTERED FINITE DIFFERENCE MULTIGRID ALGORITHM ON RECTANGULAR GRIDS. 1. Introduction Trends in Mathematics Information Center for Mathematical Sciences Volume 9 Number 2 December 2006 Pages 0 INTERGRID OPERATORS FOR THE CELL CENTERED FINITE DIFFERENCE MULTIGRID ALGORITHM ON RECTANGULAR

More information

VARIATIONAL AND NON-VARIATIONAL MULTIGRID ALGORITHMS FOR THE LAPLACE-BELTRAMI OPERATOR.

VARIATIONAL AND NON-VARIATIONAL MULTIGRID ALGORITHMS FOR THE LAPLACE-BELTRAMI OPERATOR. VARIATIONAL AND NON-VARIATIONAL MULTIGRID ALGORITHMS FOR THE LAPLACE-BELTRAMI OPERATOR. ANDREA BONITO AND JOSEPH E. PASCIAK Abstract. We design and analyze variational and non-variational multigrid algorithms

More information

Technische Universität Graz

Technische Universität Graz Technische Universität Graz Stability of the Laplace single layer boundary integral operator in Sobolev spaces O. Steinbach Berichte aus dem Institut für Numerische Mathematik Bericht 2016/2 Technische

More information

Multigrid Methods for Saddle Point Problems

Multigrid Methods for Saddle Point Problems Multigrid Methods for Saddle Point Problems Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University Advances in Mathematics of Finite Elements (In

More information

Geometric Multigrid Methods

Geometric Multigrid Methods Geometric Multigrid Methods Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University IMA Tutorial: Fast Solution Techniques November 28, 2010 Ideas

More information

Comparison of V-cycle Multigrid Method for Cell-centered Finite Difference on Triangular Meshes

Comparison of V-cycle Multigrid Method for Cell-centered Finite Difference on Triangular Meshes Comparison of V-cycle Multigrid Method for Cell-centered Finite Difference on Triangular Meshes Do Y. Kwak, 1 JunS.Lee 1 Department of Mathematics, KAIST, Taejon 305-701, Korea Department of Mathematics,

More information

Multigrid absolute value preconditioning

Multigrid absolute value preconditioning Multigrid absolute value preconditioning Eugene Vecharynski 1 Andrew Knyazev 2 (speaker) 1 Department of Computer Science and Engineering University of Minnesota 2 Department of Mathematical and Statistical

More information

A NOTE ON THE LADYŽENSKAJA-BABUŠKA-BREZZI CONDITION

A NOTE ON THE LADYŽENSKAJA-BABUŠKA-BREZZI CONDITION A NOTE ON THE LADYŽENSKAJA-BABUŠKA-BREZZI CONDITION JOHNNY GUZMÁN, ABNER J. SALGADO, AND FRANCISCO-JAVIER SAYAS Abstract. The analysis of finite-element-like Galerkin discretization techniques for the

More information

A Finite Element Method Using Singular Functions for Poisson Equations: Mixed Boundary Conditions

A Finite Element Method Using Singular Functions for Poisson Equations: Mixed Boundary Conditions A Finite Element Method Using Singular Functions for Poisson Equations: Mixed Boundary Conditions Zhiqiang Cai Seokchan Kim Sangdong Kim Sooryun Kong Abstract In [7], we proposed a new finite element method

More information

Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions

Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions Ernst P. Stephan 1, Matthias Maischak 2, and Thanh Tran 3 1 Institut für Angewandte Mathematik, Leibniz

More information

SOLVING MESH EIGENPROBLEMS WITH MULTIGRID EFFICIENCY

SOLVING MESH EIGENPROBLEMS WITH MULTIGRID EFFICIENCY SOLVING MESH EIGENPROBLEMS WITH MULTIGRID EFFICIENCY KLAUS NEYMEYR ABSTRACT. Multigrid techniques can successfully be applied to mesh eigenvalue problems for elliptic differential operators. They allow

More information

A coupled BEM and FEM for the interior transmission problem

A coupled BEM and FEM for the interior transmission problem A coupled BEM and FEM for the interior transmission problem George C. Hsiao, Liwei Xu, Fengshan Liu, Jiguang Sun Abstract The interior transmission problem (ITP) is a boundary value problem arising in

More information

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Eugene Vecharynski 1 Andrew Knyazev 2 1 Department of Computer Science and Engineering University of Minnesota 2 Department

More information

The Conjugate Gradient Method

The Conjugate Gradient Method The Conjugate Gradient Method Classical Iterations We have a problem, We assume that the matrix comes from a discretization of a PDE. The best and most popular model problem is, The matrix will be as large

More information

Abstract. 1. Introduction

Abstract. 1. Introduction Journal of Computational Mathematics Vol.28, No.2, 2010, 273 288. http://www.global-sci.org/jcm doi:10.4208/jcm.2009.10-m2870 UNIFORM SUPERCONVERGENCE OF GALERKIN METHODS FOR SINGULARLY PERTURBED PROBLEMS

More information

Iterative methods for positive definite linear systems with a complex shift

Iterative methods for positive definite linear systems with a complex shift Iterative methods for positive definite linear systems with a complex shift William McLean, University of New South Wales Vidar Thomée, Chalmers University November 4, 2011 Outline 1. Numerical solution

More information

Iterative Methods and Multigrid

Iterative Methods and Multigrid Iterative Methods and Multigrid Part 1: Introduction to Multigrid 1 12/02/09 MG02.prz Error Smoothing 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 Initial Solution=-Error 0 10 20 30 40 50 60 70 80 90 100 DCT:

More information

From the Boundary Element Domain Decomposition Methods to Local Trefftz Finite Element Methods on Polyhedral Meshes

From the Boundary Element Domain Decomposition Methods to Local Trefftz Finite Element Methods on Polyhedral Meshes From the Boundary Element Domain Decomposition Methods to Local Trefftz Finite Element Methods on Polyhedral Meshes Dylan Copeland 1, Ulrich Langer 2, and David Pusch 3 1 Institute of Computational Mathematics,

More information

A Least-Squares Finite Element Approximation for the Compressible Stokes Equations

A Least-Squares Finite Element Approximation for the Compressible Stokes Equations A Least-Squares Finite Element Approximation for the Compressible Stokes Equations Zhiqiang Cai, 1 Xiu Ye 1 Department of Mathematics, Purdue University, 1395 Mathematical Science Building, West Lafayette,

More information

Kasetsart University Workshop. Multigrid methods: An introduction

Kasetsart University Workshop. Multigrid methods: An introduction Kasetsart University Workshop Multigrid methods: An introduction Dr. Anand Pardhanani Mathematics Department Earlham College Richmond, Indiana USA pardhan@earlham.edu A copy of these slides is available

More information

Multigrid Method ZHONG-CI SHI. Institute of Computational Mathematics Chinese Academy of Sciences, Beijing, China. Joint work: Xuejun Xu

Multigrid Method ZHONG-CI SHI. Institute of Computational Mathematics Chinese Academy of Sciences, Beijing, China. Joint work: Xuejun Xu Multigrid Method ZHONG-CI SHI Institute of Computational Mathematics Chinese Academy of Sciences, Beijing, China Joint work: Xuejun Xu Outline Introduction Standard Cascadic Multigrid method(cmg) Economical

More information

An Iterative Substructuring Method for Mortar Nonconforming Discretization of a Fourth-Order Elliptic Problem in two dimensions

An Iterative Substructuring Method for Mortar Nonconforming Discretization of a Fourth-Order Elliptic Problem in two dimensions An Iterative Substructuring Method for Mortar Nonconforming Discretization of a Fourth-Order Elliptic Problem in two dimensions Leszek Marcinkowski Department of Mathematics, Warsaw University, Banacha

More information

Computational Linear Algebra

Computational Linear Algebra Computational Linear Algebra PD Dr. rer. nat. habil. Ralf-Peter Mundani Computation in Engineering / BGU Scientific Computing in Computer Science / INF Winter Term 2018/19 Part 4: Iterative Methods PD

More information

A NEW FAMILY OF STABLE MIXED FINITE ELEMENTS FOR THE 3D STOKES EQUATIONS

A NEW FAMILY OF STABLE MIXED FINITE ELEMENTS FOR THE 3D STOKES EQUATIONS MATHEMATICS OF COMPUTATION Volume 74, Number 250, Pages 543 554 S 0025-5718(04)01711-9 Article electronically published on August 31, 2004 A NEW FAMILY OF STABLE MIXED FINITE ELEMENTS FOR THE 3D STOKES

More information

PIECEWISE LINEAR FINITE ELEMENT METHODS ARE NOT LOCALIZED

PIECEWISE LINEAR FINITE ELEMENT METHODS ARE NOT LOCALIZED PIECEWISE LINEAR FINITE ELEMENT METHODS ARE NOT LOCALIZED ALAN DEMLOW Abstract. Recent results of Schatz show that standard Galerkin finite element methods employing piecewise polynomial elements of degree

More information

Domain decomposition methods via boundary integral equations

Domain decomposition methods via boundary integral equations Domain decomposition methods via boundary integral equations G. C. Hsiao a O. Steinbach b W. L. Wendland b a Department of Mathematical Sciences, University of Delaware, Newark, Delaware 19716, USA. E

More information

Chapter 7 Iterative Techniques in Matrix Algebra

Chapter 7 Iterative Techniques in Matrix Algebra Chapter 7 Iterative Techniques in Matrix Algebra Per-Olof Persson persson@berkeley.edu Department of Mathematics University of California, Berkeley Math 128B Numerical Analysis Vector Norms Definition

More information

Iterative Methods for Solving A x = b

Iterative Methods for Solving A x = b Iterative Methods for Solving A x = b A good (free) online source for iterative methods for solving A x = b is given in the description of a set of iterative solvers called templates found at netlib: http

More information

PARTITION OF UNITY FOR THE STOKES PROBLEM ON NONMATCHING GRIDS

PARTITION OF UNITY FOR THE STOKES PROBLEM ON NONMATCHING GRIDS PARTITION OF UNITY FOR THE STOES PROBLEM ON NONMATCHING GRIDS CONSTANTIN BACUTA AND JINCHAO XU Abstract. We consider the Stokes Problem on a plane polygonal domain Ω R 2. We propose a finite element method

More information

Multigrid Methods for Maxwell s Equations

Multigrid Methods for Maxwell s Equations Multigrid Methods for Maxwell s Equations Jintao Cui Institute for Mathematics and Its Applications University of Minnesota Outline Nonconforming Finite Element Methods for a Two Dimensional Curl-Curl

More information

REMARKS ON THE MEMBRANE AND BUCKLING EIGENVALUES FOR PLANAR DOMAINS. Leonid Friedlander

REMARKS ON THE MEMBRANE AND BUCKLING EIGENVALUES FOR PLANAR DOMAINS. Leonid Friedlander REMARKS ON THE MEMBRANE AND BUCKLING EIGENVALUES FOR PLANAR DOMAINS Leonid Friedlander Abstract. I present a counter-example to the conjecture that the first eigenvalue of the clamped buckling problem

More information

Lecture Note III: Least-Squares Method

Lecture Note III: Least-Squares Method Lecture Note III: Least-Squares Method Zhiqiang Cai October 4, 004 In this chapter, we shall present least-squares methods for second-order scalar partial differential equations, elastic equations of solids,

More information

Supraconvergence of a Non-Uniform Discretisation for an Elliptic Third-Kind Boundary-Value Problem with Mixed Derivatives

Supraconvergence of a Non-Uniform Discretisation for an Elliptic Third-Kind Boundary-Value Problem with Mixed Derivatives Supraconvergence of a Non-Uniform Discretisation for an Elliptic Third-Kind Boundary-Value Problem with Mixed Derivatives Etienne Emmrich Technische Universität Berlin, Institut für Mathematik, Straße

More information

10 The Finite Element Method for a Parabolic Problem

10 The Finite Element Method for a Parabolic Problem 1 The Finite Element Method for a Parabolic Problem In this chapter we consider the approximation of solutions of the model heat equation in two space dimensions by means of Galerkin s method, using piecewise

More information

Fast Multipole BEM for Structural Acoustics Simulation

Fast Multipole BEM for Structural Acoustics Simulation Fast Boundary Element Methods in Industrial Applications Fast Multipole BEM for Structural Acoustics Simulation Matthias Fischer and Lothar Gaul Institut A für Mechanik, Universität Stuttgart, Germany

More information

arxiv: v1 [math.na] 29 Feb 2016

arxiv: v1 [math.na] 29 Feb 2016 EFFECTIVE IMPLEMENTATION OF THE WEAK GALERKIN FINITE ELEMENT METHODS FOR THE BIHARMONIC EQUATION LIN MU, JUNPING WANG, AND XIU YE Abstract. arxiv:1602.08817v1 [math.na] 29 Feb 2016 The weak Galerkin (WG)

More information

Subdiffusion in a nonconvex polygon

Subdiffusion in a nonconvex polygon Subdiffusion in a nonconvex polygon Kim Ngan Le and William McLean The University of New South Wales Bishnu Lamichhane University of Newcastle Monash Workshop on Numerical PDEs, February 2016 Outline Time-fractional

More information

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis. Volume 37, pp. 166-172, 2010. Copyright 2010,. ISSN 1068-9613. ETNA A GRADIENT RECOVERY OPERATOR BASED ON AN OBLIQUE PROJECTION BISHNU P. LAMICHHANE Abstract.

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 24: Preconditioning and Multigrid Solver Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 5 Preconditioning Motivation:

More information

Solving PDEs with Multigrid Methods p.1

Solving PDEs with Multigrid Methods p.1 Solving PDEs with Multigrid Methods Scott MacLachlan maclachl@colorado.edu Department of Applied Mathematics, University of Colorado at Boulder Solving PDEs with Multigrid Methods p.1 Support and Collaboration

More information

Numerical techniques for linear and nonlinear eigenvalue problems in the theory of elasticity

Numerical techniques for linear and nonlinear eigenvalue problems in the theory of elasticity ANZIAM J. 46 (E) ppc46 C438, 005 C46 Numerical techniques for linear and nonlinear eigenvalue problems in the theory of elasticity Aliki D. Muradova (Received 9 November 004, revised April 005) Abstract

More information

An additive average Schwarz method for the plate bending problem

An additive average Schwarz method for the plate bending problem J. Numer. Math., Vol. 10, No. 2, pp. 109 125 (2002) c VSP 2002 Prepared using jnm.sty [Version: 02.02.2002 v1.2] An additive average Schwarz method for the plate bending problem X. Feng and T. Rahman Abstract

More information

A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems

A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems Etereldes Gonçalves 1, Tarek P. Mathew 1, Markus Sarkis 1,2, and Christian E. Schaerer 1 1 Instituto de Matemática Pura

More information

MULTIGRID PRECONDITIONING IN H(div) ON NON-CONVEX POLYGONS* Dedicated to Professor Jim Douglas, Jr. on the occasion of his seventieth birthday.

MULTIGRID PRECONDITIONING IN H(div) ON NON-CONVEX POLYGONS* Dedicated to Professor Jim Douglas, Jr. on the occasion of his seventieth birthday. MULTIGRID PRECONDITIONING IN H(div) ON NON-CONVEX POLYGONS* DOUGLAS N ARNOLD, RICHARD S FALK, and RAGNAR WINTHER Dedicated to Professor Jim Douglas, Jr on the occasion of his seventieth birthday Abstract

More information

Efficient smoothers for all-at-once multigrid methods for Poisson and Stokes control problems

Efficient smoothers for all-at-once multigrid methods for Poisson and Stokes control problems Efficient smoothers for all-at-once multigrid methods for Poisson and Stoes control problems Stefan Taacs stefan.taacs@numa.uni-linz.ac.at, WWW home page: http://www.numa.uni-linz.ac.at/~stefant/j3362/

More information

From the Boundary Element DDM to local Trefftz Finite Element Methods on Polyhedral Meshes

From the Boundary Element DDM to local Trefftz Finite Element Methods on Polyhedral Meshes www.oeaw.ac.at From the Boundary Element DDM to local Trefftz Finite Element Methods on Polyhedral Meshes D. Copeland, U. Langer, D. Pusch RICAM-Report 2008-10 www.ricam.oeaw.ac.at From the Boundary Element

More information

Journal of Computational and Applied Mathematics. Multigrid method for solving convection-diffusion problems with dominant convection

Journal of Computational and Applied Mathematics. Multigrid method for solving convection-diffusion problems with dominant convection Journal of Computational and Applied Mathematics 226 (2009) 77 83 Contents lists available at ScienceDirect Journal of Computational and Applied Mathematics journal homepage: www.elsevier.com/locate/cam

More information

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II Elliptic Problems / Multigrid Summary of Hyperbolic PDEs We looked at a simple linear and a nonlinear scalar hyperbolic PDE There is a speed associated with the change of the solution Explicit methods

More information

ON APPROXIMATION OF LAPLACIAN EIGENPROBLEM OVER A REGULAR HEXAGON WITH ZERO BOUNDARY CONDITIONS 1) 1. Introduction

ON APPROXIMATION OF LAPLACIAN EIGENPROBLEM OVER A REGULAR HEXAGON WITH ZERO BOUNDARY CONDITIONS 1) 1. Introduction Journal of Computational Mathematics, Vol., No., 4, 75 86. ON APPROXIMATION OF LAPLACIAN EIGENPROBLEM OVER A REGULAR HEXAGON WITH ZERO BOUNDARY CONDITIONS ) Jia-chang Sun (Parallel Computing Division,

More information

Multispace and Multilevel BDDC. Jan Mandel University of Colorado at Denver and Health Sciences Center

Multispace and Multilevel BDDC. Jan Mandel University of Colorado at Denver and Health Sciences Center Multispace and Multilevel BDDC Jan Mandel University of Colorado at Denver and Health Sciences Center Based on joint work with Bedřich Sousedík, UCDHSC and Czech Technical University, and Clark R. Dohrmann,

More information

THE BEST L 2 NORM ERROR ESTIMATE OF LOWER ORDER FINITE ELEMENT METHODS FOR THE FOURTH ORDER PROBLEM *

THE BEST L 2 NORM ERROR ESTIMATE OF LOWER ORDER FINITE ELEMENT METHODS FOR THE FOURTH ORDER PROBLEM * Journal of Computational Mathematics Vol.30, No.5, 2012, 449 460. http://www.global-sci.org/jcm doi:10.4208/jcm.1203-m3855 THE BEST L 2 NORM ERROR ESTIMATE OF LOWER ORDER FINITE ELEMENT METHODS FOR THE

More information

Title: Localized self-adjointness of Schrödinger-type operators on Riemannian manifolds. Proposed running head: Schrödinger-type operators on

Title: Localized self-adjointness of Schrödinger-type operators on Riemannian manifolds. Proposed running head: Schrödinger-type operators on Title: Localized self-adjointness of Schrödinger-type operators on Riemannian manifolds. Proposed running head: Schrödinger-type operators on manifolds. Author: Ognjen Milatovic Department Address: Department

More information

arxiv: v1 [math.na] 11 Jul 2011

arxiv: v1 [math.na] 11 Jul 2011 Multigrid Preconditioner for Nonconforming Discretization of Elliptic Problems with Jump Coefficients arxiv:07.260v [math.na] Jul 20 Blanca Ayuso De Dios, Michael Holst 2, Yunrong Zhu 2, and Ludmil Zikatanov

More information

A MULTILEVEL SUCCESSIVE ITERATION METHOD FOR NONLINEAR ELLIPTIC PROBLEMS

A MULTILEVEL SUCCESSIVE ITERATION METHOD FOR NONLINEAR ELLIPTIC PROBLEMS MATHEMATICS OF COMPUTATION Volume 73, Number 246, Pages 525 539 S 0025-5718(03)01566-7 Article electronically published on July 14, 2003 A MULTILEVEL SUCCESSIVE ITERATION METHOD FOR NONLINEAR ELLIPTIC

More information

Stabilization and Acceleration of Algebraic Multigrid Method

Stabilization and Acceleration of Algebraic Multigrid Method Stabilization and Acceleration of Algebraic Multigrid Method Recursive Projection Algorithm A. Jemcov J.P. Maruszewski Fluent Inc. October 24, 2006 Outline 1 Need for Algorithm Stabilization and Acceleration

More information

Step lengths in BFGS method for monotone gradients

Step lengths in BFGS method for monotone gradients Noname manuscript No. (will be inserted by the editor) Step lengths in BFGS method for monotone gradients Yunda Dong Received: date / Accepted: date Abstract In this paper, we consider how to directly

More information

Solving PDEs with CUDA Jonathan Cohen

Solving PDEs with CUDA Jonathan Cohen Solving PDEs with CUDA Jonathan Cohen jocohen@nvidia.com NVIDIA Research PDEs (Partial Differential Equations) Big topic Some common strategies Focus on one type of PDE in this talk Poisson Equation Linear

More information

The amount of work to construct each new guess from the previous one should be a small multiple of the number of nonzeros in A.

The amount of work to construct each new guess from the previous one should be a small multiple of the number of nonzeros in A. AMSC/CMSC 661 Scientific Computing II Spring 2005 Solution of Sparse Linear Systems Part 2: Iterative methods Dianne P. O Leary c 2005 Solving Sparse Linear Systems: Iterative methods The plan: Iterative

More information

A P4 BUBBLE ENRICHED P3 DIVERGENCE-FREE FINITE ELEMENT ON TRIANGULAR GRIDS

A P4 BUBBLE ENRICHED P3 DIVERGENCE-FREE FINITE ELEMENT ON TRIANGULAR GRIDS A P4 BUBBLE ENRICHED P3 DIVERGENCE-FREE FINITE ELEMENT ON TRIANGULAR GRIDS SHANGYOU ZHANG DEDICATED TO PROFESSOR PETER MONK ON THE OCCASION OF HIS 6TH BIRTHDAY Abstract. On triangular grids, the continuous

More information

Numerical Methods for Partial Differential Equations

Numerical Methods for Partial Differential Equations Numerical Methods for Partial Differential Equations Steffen Börm Compiled July 12, 2018, 12:01 All rights reserved. Contents 1. Introduction 5 2. Finite difference methods 7 2.1. Potential equation.............................

More information

Recurrence Relations and Fast Algorithms

Recurrence Relations and Fast Algorithms Recurrence Relations and Fast Algorithms Mark Tygert Research Report YALEU/DCS/RR-343 December 29, 2005 Abstract We construct fast algorithms for decomposing into and reconstructing from linear combinations

More information

Technische Universität Graz

Technische Universität Graz Technische Universität Graz A note on the stable coupling of finite and boundary elements O. Steinbach Berichte aus dem Institut für Numerische Mathematik Bericht 2009/4 Technische Universität Graz A

More information

Spectral Processing. Misha Kazhdan

Spectral Processing. Misha Kazhdan Spectral Processing Misha Kazhdan [Taubin, 1995] A Signal Processing Approach to Fair Surface Design [Desbrun, et al., 1999] Implicit Fairing of Arbitrary Meshes [Vallet and Levy, 2008] Spectral Geometry

More information

Preface to the Second Edition. Preface to the First Edition

Preface to the Second Edition. Preface to the First Edition n page v Preface to the Second Edition Preface to the First Edition xiii xvii 1 Background in Linear Algebra 1 1.1 Matrices................................. 1 1.2 Square Matrices and Eigenvalues....................

More information

Aspects of Multigrid

Aspects of Multigrid Aspects of Multigrid Kees Oosterlee 1,2 1 Delft University of Technology, Delft. 2 CWI, Center for Mathematics and Computer Science, Amsterdam, SIAM Chapter Workshop Day, May 30th 2018 C.W.Oosterlee (CWI)

More information

Nonlinear Schrödinger problems: symmetries of some variational solutions

Nonlinear Schrödinger problems: symmetries of some variational solutions Nonlinear Differ. Equ. Appl. (3), 5 5 c Springer Basel AG -97/3/35- published online April 3, DOI.7/s3--3- Nonlinear Differential Equations and Applications NoDEA Nonlinear Schrödinger problems: symmetries

More information

A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations

A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations S. Hussain, F. Schieweck, S. Turek Abstract In this note, we extend our recent work for

More information

Fast Structured Spectral Methods

Fast Structured Spectral Methods Spectral methods HSS structures Fast algorithms Conclusion Fast Structured Spectral Methods Yingwei Wang Department of Mathematics, Purdue University Joint work with Prof Jie Shen and Prof Jianlin Xia

More information

arxiv: v2 [math.na] 16 Nov 2016

arxiv: v2 [math.na] 16 Nov 2016 BOOTSTRAP MULTIGRID FOR THE SHIFTED LAPLACE-BELTRAMI EIGENVALUE PROBLEM JAMES BRANNICK AND SHUHAO CAO arxiv:1511.07042v2 [math.na] 16 Nov 2016 Abstract. This paper introduces bootstrap two-grid and multigrid

More information

Some lecture notes for Math 6050E: PDEs, Fall 2016

Some lecture notes for Math 6050E: PDEs, Fall 2016 Some lecture notes for Math 65E: PDEs, Fall 216 Tianling Jin December 1, 216 1 Variational methods We discuss an example of the use of variational methods in obtaining existence of solutions. Theorem 1.1.

More information

Second Order Elliptic PDE

Second Order Elliptic PDE Second Order Elliptic PDE T. Muthukumar tmk@iitk.ac.in December 16, 2014 Contents 1 A Quick Introduction to PDE 1 2 Classification of Second Order PDE 3 3 Linear Second Order Elliptic Operators 4 4 Periodic

More information

A Multigrid Method for Two Dimensional Maxwell Interface Problems

A Multigrid Method for Two Dimensional Maxwell Interface Problems A Multigrid Method for Two Dimensional Maxwell Interface Problems Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University USA JSA 2013 Outline A

More information

The All-floating BETI Method: Numerical Results

The All-floating BETI Method: Numerical Results The All-floating BETI Method: Numerical Results Günther Of Institute of Computational Mathematics, Graz University of Technology, Steyrergasse 30, A-8010 Graz, Austria, of@tugraz.at Summary. The all-floating

More information

ELLIPTIC RECONSTRUCTION AND A POSTERIORI ERROR ESTIMATES FOR PARABOLIC PROBLEMS

ELLIPTIC RECONSTRUCTION AND A POSTERIORI ERROR ESTIMATES FOR PARABOLIC PROBLEMS ELLIPTIC RECONSTRUCTION AND A POSTERIORI ERROR ESTIMATES FOR PARABOLIC PROBLEMS CHARALAMBOS MAKRIDAKIS AND RICARDO H. NOCHETTO Abstract. It is known that the energy technique for a posteriori error analysis

More information

MULTIGRID PRECONDITIONING FOR THE BIHARMONIC DIRICHLET PROBLEM M. R. HANISCH

MULTIGRID PRECONDITIONING FOR THE BIHARMONIC DIRICHLET PROBLEM M. R. HANISCH MULTIGRID PRECONDITIONING FOR THE BIHARMONIC DIRICHLET PROBLEM M. R. HANISCH Abstract. A multigrid preconditioning scheme for solving the Ciarlet-Raviart mixed method equations for the biharmonic Dirichlet

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 11 Partial Differential Equations Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002.

More information

A POSTERIORI ERROR ESTIMATES BY RECOVERED GRADIENTS IN PARABOLIC FINITE ELEMENT EQUATIONS

A POSTERIORI ERROR ESTIMATES BY RECOVERED GRADIENTS IN PARABOLIC FINITE ELEMENT EQUATIONS A POSTERIORI ERROR ESTIMATES BY RECOVERED GRADIENTS IN PARABOLIC FINITE ELEMENT EQUATIONS D. LEYKEKHMAN AND L. B. WAHLBIN Abstract. This paper considers a posteriori error estimates by averaged gradients

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

A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation

A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation Tao Zhao 1, Feng-Nan Hwang 2 and Xiao-Chuan Cai 3 Abstract In this paper, we develop an overlapping domain decomposition

More information

Research Statement. Xiangjin Xu. 1. My thesis work

Research Statement. Xiangjin Xu. 1. My thesis work Research Statement Xiangjin Xu My main research interest is twofold. First I am interested in Harmonic Analysis on manifolds. More precisely, in my thesis, I studied the L estimates and gradient estimates

More information

Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses

Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses P. Boyanova 1, I. Georgiev 34, S. Margenov, L. Zikatanov 5 1 Uppsala University, Box 337, 751 05 Uppsala,

More information

SELF-ADJOINTNESS OF SCHRÖDINGER-TYPE OPERATORS WITH SINGULAR POTENTIALS ON MANIFOLDS OF BOUNDED GEOMETRY

SELF-ADJOINTNESS OF SCHRÖDINGER-TYPE OPERATORS WITH SINGULAR POTENTIALS ON MANIFOLDS OF BOUNDED GEOMETRY Electronic Journal of Differential Equations, Vol. 2003(2003), No.??, pp. 1 8. ISSN: 1072-6691. URL: http://ejde.math.swt.edu or http://ejde.math.unt.edu ftp ejde.math.swt.edu (login: ftp) SELF-ADJOINTNESS

More information

PREPRINT 2010:25. Fictitious domain finite element methods using cut elements: II. A stabilized Nitsche method ERIK BURMAN PETER HANSBO

PREPRINT 2010:25. Fictitious domain finite element methods using cut elements: II. A stabilized Nitsche method ERIK BURMAN PETER HANSBO PREPRINT 2010:25 Fictitious domain finite element methods using cut elements: II. A stabilized Nitsche method ERIK BURMAN PETER HANSBO Department of Mathematical Sciences Division of Mathematics CHALMERS

More information

A SHORT NOTE COMPARING MULTIGRID AND DOMAIN DECOMPOSITION FOR PROTEIN MODELING EQUATIONS

A SHORT NOTE COMPARING MULTIGRID AND DOMAIN DECOMPOSITION FOR PROTEIN MODELING EQUATIONS A SHORT NOTE COMPARING MULTIGRID AND DOMAIN DECOMPOSITION FOR PROTEIN MODELING EQUATIONS MICHAEL HOLST AND FAISAL SAIED Abstract. We consider multigrid and domain decomposition methods for the numerical

More information

Non-Conforming Finite Element Methods for Nonmatching Grids in Three Dimensions

Non-Conforming Finite Element Methods for Nonmatching Grids in Three Dimensions Non-Conforming Finite Element Methods for Nonmatching Grids in Three Dimensions Wayne McGee and Padmanabhan Seshaiyer Texas Tech University, Mathematics and Statistics (padhu@math.ttu.edu) Summary. In

More information

On Surface Meshes Induced by Level Set Functions

On Surface Meshes Induced by Level Set Functions On Surface Meshes Induced by Level Set Functions Maxim A. Olshanskii, Arnold Reusken, and Xianmin Xu Bericht Nr. 347 Oktober 01 Key words: surface finite elements, level set function, surface triangulation,

More information

arxiv: v1 [math.na] 1 Sep 2018

arxiv: v1 [math.na] 1 Sep 2018 On the perturbation of an L -orthogonal projection Xuefeng Xu arxiv:18090000v1 [mathna] 1 Sep 018 September 5 018 Abstract The L -orthogonal projection is an important mathematical tool in scientific computing

More information

Key words. preconditioned conjugate gradient method, saddle point problems, optimal control of PDEs, control and state constraints, multigrid method

Key words. preconditioned conjugate gradient method, saddle point problems, optimal control of PDEs, control and state constraints, multigrid method PRECONDITIONED CONJUGATE GRADIENT METHOD FOR OPTIMAL CONTROL PROBLEMS WITH CONTROL AND STATE CONSTRAINTS ROLAND HERZOG AND EKKEHARD SACHS Abstract. Optimality systems and their linearizations arising in

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

A Posteriori Existence in Adaptive Computations

A Posteriori Existence in Adaptive Computations Report no. 06/11 A Posteriori Existence in Adaptive Computations Christoph Ortner This short note demonstrates that it is not necessary to assume the existence of exact solutions in an a posteriori error

More information

LOCAL MULTILEVEL METHODS FOR ADAPTIVE NONCONFORMING FINITE ELEMENT METHODS

LOCAL MULTILEVEL METHODS FOR ADAPTIVE NONCONFORMING FINITE ELEMENT METHODS LOCAL MULTILEVEL METHODS FOR ADAPTIVE NONCONFORMING FINITE ELEMENT METHODS XUEUN XU, HUANGXIN CHEN, AND RONALD H.W. HOPPE Abstract. In this paper, we propose a local multilevel product algorithm and its

More information

3D Space Charge Routines: The Software Package MOEVE and FFT Compared

3D Space Charge Routines: The Software Package MOEVE and FFT Compared 3D Space Charge Routines: The Software Package MOEVE and FFT Compared Gisela Pöplau DESY, Hamburg, December 4, 2007 Overview Algorithms for 3D space charge calculations Properties of FFT and iterative

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

Maximum norm estimates for energy-corrected finite element method

Maximum norm estimates for energy-corrected finite element method Maximum norm estimates for energy-corrected finite element method Piotr Swierczynski 1 and Barbara Wohlmuth 1 Technical University of Munich, Institute for Numerical Mathematics, piotr.swierczynski@ma.tum.de,

More information

ACM/CMS 107 Linear Analysis & Applications Fall 2017 Assignment 2: PDEs and Finite Element Methods Due: 7th November 2017

ACM/CMS 107 Linear Analysis & Applications Fall 2017 Assignment 2: PDEs and Finite Element Methods Due: 7th November 2017 ACM/CMS 17 Linear Analysis & Applications Fall 217 Assignment 2: PDEs and Finite Element Methods Due: 7th November 217 For this assignment the following MATLAB code will be required: Introduction http://wwwmdunloporg/cms17/assignment2zip

More information

Institut für Mathematik

Institut für Mathematik U n i v e r s i t ä t A u g s b u r g Institut für Mathematik Xuejun Xu, Huangxin Chen, Ronald H.W. Hoppe Local Multilevel Methods for Adaptive Nonconforming Finite Element Methods Preprint Nr. 21/2009

More information

Introduction. Chapter One

Introduction. Chapter One Chapter One Introduction The aim of this book is to describe and explain the beautiful mathematical relationships between matrices, moments, orthogonal polynomials, quadrature rules and the Lanczos and

More information

Constrained Minimization and Multigrid

Constrained Minimization and Multigrid Constrained Minimization and Multigrid C. Gräser (FU Berlin), R. Kornhuber (FU Berlin), and O. Sander (FU Berlin) Workshop on PDE Constrained Optimization Hamburg, March 27-29, 2008 Matheon Outline Successive

More information