c 2006 Society for Industrial and Applied Mathematics BJÖRN ENGQUIST

Size: px
Start display at page:

Download "c 2006 Society for Industrial and Applied Mathematics BJÖRN ENGQUIST"

Transcription

1 SIAM J. NUMER. ANAL. Vol. 44, No. 5, pp c 2006 Society for Industrial and Applied Mathematics OPTIMAL DISCONTINUOUS GALERKIN METHODS FOR WAVE PROPAGATION ERIC T. CHUNG AND BJÖRN ENGQUIST Abstract. We have developed and analyzed a new class of discontinuous Galerkin methods (DG) which can be seen as a compromise between standard DG and the finite element (FE) method in the way that it is explicit like standard DG and energy conserving like FE. In the literature there are many methods that achieve some of the goals of explicit time marching, unstructured grid, energy conservation, and optimal higher order accuracy, but as far as we know only our new algorithms satisfy all the conditions. We propose a new stability requirement for our DG. The stability analysis is based on the careful selection of the two FE spaces which verify the new stability condition. The convergence rate is optimal with respect to the order of the polynomials in the FE spaces. Moreover, the convergence is described by a series of numerical experiments. Key words. discontinuous Galerkin, wave propagation, optimal rate of convergence AMS subject classifications. 65M12, 65M15, 65M60, 78M10 DOI / Introduction. Many applications involve the solution of wave equations. Examples are electromagnetic waves for radar and communication as well as acoustic and seismic wave propagation. Let R 2 be a two dimensional polygonal domain with outward normal vector n and let T > 0 be a fixed time. Given two positive constants a 1 > 0, a 2 > 0 and two given functions F 1 (x, t), F 2 (x, t), we will consider, for (x, t) (0,T), the following wave propagation problem: find a function u(x, t) and a vector field v(x, t) R 2 such that (1.1) u a 1 t + Bv = F 1, (1.2) v a 2 t B u = F 2, where the two operators B and B satisfy (1.3) (B φ)ψ dx 0 (Bψ)φ dx= 0 (Lψ)φ d 0 for all subset 0. Here L is some operator depending on the two operators B, B and the subdomain 0. We also denote by L the operator such that ψ 2 = Lψ 2 + L ψ 2. Assume that there is an operator B such that BB p = 0 for all p. Acting (B ) to (1.2) and using (B ) B = 0, we have the following: (1.4) t (a 2(B ) v)=(b ) F 2. Received by the editors September 26, 2005; accepted for publication (in revised form) April 6, 2006; published electronically November 3, Applied and Computational Mathematics, California Institute of Technology, Pasadena, CA (tschung@acm.caltech.edu). Department of Mathematics, University of Texas at Austin, Austin, TX (engquist@math. utexas.edu). 2131

2 2132 ERIC T. CHUNG AND BJÖRN ENGQUIST The condition (1.4) usually has important physical significance. For example, in the case of electromagnetic wave propagation (see (E) in the following), v represents the electric field, (B ) is the divergence operator, and (1.4) is just the continuity equation expressing the conservation of charges. We supplement the system (1.1) (1.2) with boundary condition (1.5) and initial conditions Lv =0 x (1.6) u(x, 0) = u 0 (x) and v(x, 0) = v 0 (x) x, where u 0 (x) and v 0 (x) are given. In particular, we are interested in the acoustic and the electromagnetic wave equations, which correspond to the following choice of B and B : (A) Acoustic: Bv = v, B u = u, and Lv = v n. (E) Electromagnetic: Bv = v, B u = u, and Lv = v n. Notice that, in (1.1) (1.2), u(x, t) is a function while v(x, t) =(v 1 (x, t),v 2 (x, t)) is a vector having two components. So the operator is defined as v = 1 v 2 2 v 1 for any vector field v and u =( 2 u, 1 u) for any function u. Here v n = v 1 n 2 v 2 n 1 with n =(n 1,n 2 ). In (A) and (E), we use n to denote generically the unit normal vector of the corresponding subdomain which defines L and L. Moreover, we have L ψ = ψ n for (A) while L ψ = ψ n for (E). Furthermore, we have B p = p and (B ) p = p for (A) while B p = p and (B ) p = p for (E). Wave propagation problems can be solved by partial differential equation (PDE) techniques, integral equation techniques, and asymptotic techniques. Among PDE techniques, finite difference (FD) method, finite volume (FV) method, finite element (FE) method, and discontinuous Galerkin (DG) method are the most popular choices. The FD method provides a simple way to solve wave propagation problems, but it is typically low order and applies only to structured grids. The FV method can be seen as a generalization of the FD method to unstructured grids, but it is still low order. The FE and DG methods provide high order solvers for the time dependent wave equations on unstructured grids. Nédélec [15] introduces a curl-conforming FE method for solving Maxwell s equations. Geveci [8] proposed a mixed FE method for the scalar wave equation. The inversion of the mass matrix at each time step causes some possible drawback in the efficiency of those methods. Mass lumping techniques can be used to avoid solving linear systems. In Cohen and Monk [6], a mass lumping method for rectangular grids is developed. In Bécache, Joly, and Tsogka [1], a new class of mixed FE method, which is suitable for mass lumping, is developed for the scalar wave equation. Cohen, Joly, Torjman, and Roberts [5] design a mass lumping technique for triangular grids for polynomial order up to five. Discontinuous Galerkin methods provide explicit schemes in the sense that only block diagonal mass matrices have to be inverted. Hesthaven and Warburton [10] proposed a DG method based on upwind flux and Cockburn, Li, and Shu [4] proposed a DG method based on locally divergence free basis and upwind flux. While the schemes are successful, energy is not conserved due to the upwinding. Fezoui, Lanteri, Lohrengel, and Piperno [7] proposed a DG method based on central flux. This method preserves energy, but the convergence rate of the scheme is suboptimal. Recently, a new DG method has been developed for the wave equation in second order form; see Grote, Schneebeli, and Schötzau [9]. The method is also energy conserving

3 OPTIMAL DISCONTINUOUS GALERKIN METHODS 2133 DG Our DG v u both u and v are discontinuous u and v are continuous at different points FE both u and v are continuous Fig Comparison among standard DG, our new DG, and FE methods. in the sense of a newly defined energy. A space-time DG method has also been developed in Monk and Richter [14]. In this paper, we will develop and analyze a new class of DG methods which can be seen as a compromize between FE and DG methods. Our new DG method combines the advantages of FE and DG methods in the sense that it is both energy conserving and explicit. The idea is to use discontinuous functions with extra continuity. In the velocity-potential formulation of the scalar wave equation (A), we will add extra continuity to the velocity where the potential is discontinuous and add extra continuity to the potential where the velocity is discontinuous. For Maxwell s equations (E), a similar idea can be applied to the electric and magnetic fields. As a result, the flux integrals are evaluated exactly, which is the basis of energy conservation. However, the addition of the extra continuity cannot be done arbitrarily due to stability concerns. It has to be done in such a way that some inf-sup conditions are satisfied. In Figure 1.1, we illustrate this idea in one space dimension. For standard DG, both unknown functions u and v, which are velocity and potential for scalar wave equation and are electric and magnetic fields for Maxwell s equations, are discontinuous at cell boundaries. For FE methods, both u and v are continuous. For our new DG, the two functions are continuous at different points. Yee s scheme [16] has been a very popular numerical method for computational electromagnetics. It is a second order central FD method on structured grids. The success of the scheme is due to the use of a staggered grid. Our new DG method is a FE method on staggered grids and can be seen as a higher generalization of Yee s scheme on unstructured grids. In particular, in one space dimension, our new DG method with piecewise constant approximation is the same as Yee s scheme. In two space dimensions, our new DG method in the lowest order is some averaged version of Yee s scheme. The rest of the paper is organized as follows. In section 2, we will introduce the new FE spaces and prove the corresponding unisolvence and interpolation error estimates. The new DG is then derived in section 3. In section 4, under the assumption of some inf-sup conditions, the stability and convergence of the method are proved. The inf-sup conditions are then verified in section 5. Furthermore, some numerical experiments are presented in section 6. The paper ends with a conclusion. Remark. We consider only two space dimensions in this paper. For three space dimensions, a careful choice of the two FE spaces U h and V h that verify (3.1) and

4 2134 ERIC T. CHUNG AND BJÖRN ENGQUIST (3.2) as well as the two inf-sup conditions (4.1) (4.2) are required. This work will be developed in a forthcoming paper. 2. FE spaces. Assume the domain is triangulated by a family of triangles T so that = { T}. Let T. We define h as the diameter of and ρ as the supremum of the diameters of the circles inscribed in. The mesh size h is defined as h = max T h. We will assume the set of triangles T forms a regular family of triangulation of so that there exist a uniform constant K independent of the mesh size such that [3] h Kρ T. In addition, we will assume the triangulation satisfies the inverse assumption [3]. Let E be the set of all edges and let E 0 E be the set of all interior edges of the triangles in T. The length of E will be denoted by h. We also denote by N the set of all interior nodes of the triangles in T. Here, by interior edge and interior node, we mean any edge and node that does not lie on the boundary. Let ν N. We define (2.1) S(ν) = { T ν }. That is, S(ν) is the union of all triangles having vertex ν. We will assume the triangulation of satisfies the following condition. Assumption on triangulation: There exists a subset N 1 N such that (A1) = {S(ν) ν N 1 }. (A2) S(ν i ) S(ν j ) E 0 for all distinct ν i,ν j N 1. Let ν N 1. We define (2.2) E u (ν) ={ E ν }. That is, E u (ν) is the set of all edges that have ν as one of their endpoints. We further define (2.3) E u = {E u (ν) ν N 1 } and E v = E\E u. Notice that E u contains only interior edges since one of the endpoints of edges in E u has a vertex from N 1. On the other hand, E v has both interior and boundary edges. So, we also define Ev 0 = E v E 0 which contains elements from E v that are interior edges. Notice that we have E v \Ev 0 = E. Furthermore, for Ev 0, we will let R() be the union of the two triangles sharing the same edge. For E v \Ev 0,we will let R() be the only triangle having the edge. In practice, triangulations that satisfy assumptions (A1) (A2) are not difficult to construct. In Figure 2.1, we illustrate how this kind of triangulation is generated. First, the domain is triangulated by a family of triangles, called T. Each triangle in this family is then subdivided into three subtriangles by connecting a point inside the triangle with its three vertices. Then we define the union of all these subtriangles to be our triangulation T. Each triangle in T corresponds to an S(ν) for some ν inside the triangle. In Figure 2.1, we show two of the triangles, enclosed by solid lines, in this family T. This corresponds to 6 triangles in the triangulation T. The dotted lines represent edges in the set E u while solid lines represent edges in the set E v. Lemma 2.1. Each T has exactly two edges that belong to E u.

5 OPTIMAL DISCONTINUOUS GALERKIN METHODS 2135 S(ν 1 ) ν 1 ν 2 S(ν 2 ) Fig Triangulation. Proof. First of all, has at least one interior vertex. We will show that there is exactly one vertex of that belongs to N 1. If none of the three vertices of belong to N 1, then 0 S(ν) is an empty set for all ν N 1, where 0 is the interior of. Then, {S(ν) ν N 1 } 0 is an empty set. So, {S(ν) ν N 1 }, which violates assumption (A1). If has two vertices, ν i and ν j, that belong to N 1, then S(ν i ) S(ν j ) contains. So, it violates assumption (A2). The case that has all vertices belonging to N 1 can be discussed in the same way. In conclusion, has exactly one vertex which belongs to N 1. So, by the definition of E u, the two edges having the vertex in N 1 belong to E u. Given T, we will denote by ν() 1, ν() 2, and ν() 3 the three vertices of. Moreover, ν() 1 is the vertex that is one of the endpoints of the two edges of that belong to E u. Then ν() 2 and ν() 3 are named in a counterclockwise direction. In addition, λ,1 (x), λ,2 (x), and λ,3 (x) are the barycentric coordinates on with respect to the three vertices ν() 1, ν() 2, and ν() 3. Now, we will discuss the FE spaces. Let k 0 be a nonnegative integer. Let T. We define P k () as the space of polynomials of degree less than or equal to k on. We also define (2.4) R k () =P k () P k+1 (), where P k+1 () is the space of homogeneous polynomials of degree k+1 on in the two variables λ,2 and λ,3 such that the sum of the coefficients of λ k+1,2 and λk+1,3 is equal to zero. That is, any function in P k+1 () can be written as i+j=k+1,i 0,j 0 a i,jλ i,2λ j,3 such that a k+1,0 + a 0,k+1 = 0. Now, we define U h = {φ φ R k (); φ is continuous at the k + 1 Gaussian points of E u }. For any edge, we use P k () to represent the space of one dimensional polynomials of degree less than or equal to k on. We define the following degrees of freedom: (UD1) For each edge E u,wehave φp k d for all p k P k (). (UD2) For each triangle T,we have for all p k 1 P k 1 () (for k 1). φp k 1 dx

6 2136 ERIC T. CHUNG AND BJÖRN ENGQUIST Notice that (UD1) is equivalent to φ(α i ) where α i, for i =1, 2,...,k + 1, are the k + 1 Gaussian points of. For a smooth function φ, we will define I u φ U h by the following degrees of freedom: (U1) For each edge E u,wehave (I u φ φ)p k =0 for all p k P k (). (U2) For each triangle T,wehave (I u φ φ)p k 1 dx =0 for all p k 1 P k 1 () (for k 1). Theorem 2.2. Let I u :Π ν N1 W k+1,p (S(ν)) U h. Then I u is uniquely determined by (U1) (U2). Moreover, (2.5) φ I u φ W m,p (S(ν)) Kh k+1 m φ W k+1,p (S(ν)). Proof. Notice that dim(p k )= 1 2 (k + 1)(k + 2). Then (UD1) gives (k +1) E u conditions while (UD2) gives 1 2k(k +1) T conditions where S is the number of elements in the set S. Notice that S(ν) = E u (ν) for all ν N 1. So, by the assumption (A1) (A2) and the definition of E u, we have T = ν N 1 S(ν) = ν N 1 E u (ν) = E u. So, the total number of degrees of freedom defined by (UD1) (UD2) is 1 2 (k + 1)(k + 2) T. Next, we will find the dim(u h ). Notice that dim( P k+1 ()) = k + 1. So, we have dim(u h )= 1 2 (k + 1)(k +2) T +(k +1) T (k +1) E u, where the subtraction of the third term is due to the continuity condition imposed on the k + 1 Gaussian points of each edge in E u. Since T = E u, we have dim(u h )= 1 2 (k + 1)(k +2) T, which is equal to the number of degrees of freedom defined by (UD1) (UD2). Next, we will show I u φ =0ifφ = 0. Let T. Then the degree of freedom (UD1) implies that I u φ is zero at the k + 1 Gaussian points of the two edges of that belong to E u. More precisely, we denote by α j (j =1, 2,...,k + 1) the k +1 Gaussian points of the edge of having endpoints ν() 1 and ν() 2. Then we define real numbers w j (j =1, 2,...,k+ 1) such that 0 <w 1 <w 2 < <w k+1 < 1 and α j =(1 w j )ν() 1 + w j ν() 2. Moreover, we denote by β j (j =1, 2,...,k+ 1) the k + 1 Gaussian points of the edge of having endpoints ν() 1 and ν() 3. Then the real numbers w j also satisfy β j =(1 w j )ν() 1 + w j ν() 3. So, we have I u φ = cπ k+1 j=1 (λ,2 w j )+cπ k+1 j=1 (λ,3 w j ) c( 1) k+1 Π k+1 j=1 w j + λ,2 λ,3 q k 1 for some q k 1 P k 1 (). By the definition of R k (), the sum of the coefficients of λ k+1,2 and λk+1,3 is zero. So, we have c = 0. Using (UD2), we have λ,2λ,3 qk 1 2 dx =0. Since λ,2 λ,3 > 0 in the interior of, wehaveq k 1 = 0. Hence, I u φ =0. Now, we will prove (2.5). Let T and let p k P k (). It suffices to show that I u preserves polynomials. By (U1), I u p k p k is zero at the k + 1 Gaussian points of the two edges that belong to E u. So, I u p k p k = bπ k+1 j=1 (λ,2 w j )+bπ k+1 j=1 (λ,3 w j ) b( 1) k+1 Π k+1 j=1 w j + λ,2 λ,3 r k 1

7 OPTIMAL DISCONTINUOUS GALERKIN METHODS 2137 for some constant d and r k 1 P k 1 (). Since I u p k R k (), we have b = 0. Using (U2), we have r k 1 = 0. Hence, I u p k = p k. We define V h = {ψ ψ P k () 2 ; Lψ is continuous along E v ; Lψ =0on }. We also define the following degrees of freedom: (VD1) For each triangle T,wehave (L ψ)p k dx p k P k (). (VD2) For each triangle T,wehave (Lψ)λ,1 p k 1 dx (VD3) For each edge Ev 0,wehave (Lψ)q k d p k 1 P k 1 (). q k P k (). Furthermore, for a smooth vector field ψ, we define I v ψ as the corresponding interpolation operator by the following degrees of freedom: (V1) For each triangle T,wehave L (I v ψ ψ)p k dx =0 p k P k (). (V2) For each triangle T,wehave L(I v ψ ψ)λ,1 p k 1 dx =0 p k 1 P k 1 (). (V3) For each edge Ev 0,wehave L(I v ψ ψ)q k d =0 q k P k (). Theorem 2.3. Let I v :Π E 0 v W k+1,p (R()) 2 V h. Then I v is uniquely determined by (V1), (V2), and (V3). Moreover, (2.6) ψ I v ψ W m,p (R()) 2 Khk+1 m ψ W k+1,p (R()) 2. Proof. First of all, the number of degrees of freedom defined by (VD1), (VD2), and (VD3) are 1 2 (k + 1)(k +2) T, 1 2 k(k +1) T, and (k +1) E 0 v, respectively. Also, the dimension of V h is given by dim(v h )=2 1 2 (k + 1)(k +2) T (k +1) E 0 v (k +1) E v \E 0 v, where the second term on the right-hand side is due to the continuity condition that Lψ is continuous on for all E 0 v, and the third term on the right-hand side is due to the boundary condition Lψ =0on. Notice that T =2 E 0 v + E v \E 0 v.

8 2138 ERIC T. CHUNG AND BJÖRN ENGQUIST Fig S(ν) for k =1. ν() 3 ν() 1 ν() 2 Fig A single triangle for k =1. Now, a direct calculation shows that dim(v h ) is equal to the total number of degrees of freedom defined by (VD1), (VD2), and (VD3). Now, we will show I v ψ =0ifψ = 0. First, (VD1) implies that L (I v ψ)=0on each T. Using (VD3), we have L(I v ψ) = 0 on each E 0 v. So, on each T, we have L(I v ψ)=λ,1 q k 1 for some q k 1 P k 1 (). Indeed, we can write L(I v ψ)=a + k (b j λ j,1 + c jλ j,2 ). j=1 Since L(I v ψ) = 0, we have a =0,c j = 0, and L(I v ψ)= k j=1 b jλ j,1. Applying (VD2), we have L(I v ψ) = 0 on each T. Since I v ψ 2 = L (I v ψ) 2 + L(I v ψ) 2, we have I v ψ =0. The estimate (2.6) follows from the fact that the operator I v preserves polynomials of degree k. Let us consider an example for k =1. ForU h, the degrees of freedom are the two Gaussian points on each edge belonging to E u and the cell center. In Figure 2.2, we illustrate three triangles in the triangulation which corresponds to an S(ν) for some ν N 1. The dotted lines denote edges from the set E u while solid lines denote edges from the set E v. The solid dots denote the continuity points defined by (UD1), which are the two Gaussian points of the edges in E u. The circle in each triangle represents the degree of freedom defined by (UD2). In Figure 2.3, we show the degrees of freedom on a single triangle. Any function φ R k () can be expressed as φ = a + bλ,2 + cλ,3 + d(λ 2,2 λ 2,3)+eλ,2 λ,3. For V h, Lψ is defined as a linear function which is continuous on the edge while L is defined as a linear function on each triangle with no continuity requirement. In Figure 2.4, we illustrate an R() for some E 0 v, where is represented by the solid line. We represent the degrees of freedom of Lψ by solid dots and the degrees of freedom of L ψ by circles.

9 OPTIMAL DISCONTINUOUS GALERKIN METHODS 2139 Fig R() for k =1. 3. The new scheme. In this section, we will derive the new discontinuous Galerkin method for the wave propagation problem (1.1) (1.2). Multiplying both sides of (1.1) by φ, integrating the resulting equation on S(ν), and using (1.3) yields u a 1 t φdx+ (B φ)v dx (Lv)φ d= F 1 φ dx. S(ν) S(ν) Summing over all ν N 1, u a 1 t φdx+ (B φ)v dx ν N 1 S(ν) S(ν) (Lv)φ d= S(ν) F 1 φ dx. If Lv is continuous along each Ev 0 and Lv is zero along each edge in E v \Ev 0, then (Lv)φ d= (3.1) (Lv)[φ] d, ν N 1 S(ν) where [φ] =φ + φ is the jump of φ along. Similarly, multiplying both sides of (1.2) by ψ, integrating the resulting equation on R(), and using (1.3) yields v a 2 t ψdx (Bψ)u dx (Lψ)u d= F 2 ψ dx. R() R() E 0 v Summing for all E v, v a 2 t ψdx (Bψ)u dx E v R() R() (Lψ)u d= R() F 2 ψ dx. Now if Lψ is a polynomial of degree k and u isa(k + 1)th degree polynomial which is continuous at the k + 1 Gaussian points of E u, then (Lψ)u d= (3.2) [Lψ]u d, E v R() where [Lψ] denotes the jump of Lψ along. Then, the new discontinuous Galerkin method is defined as follows. The new discontinuous Galerkin method: Find u h U h and v h V h such that u h (3.3) a 1 t φdx+ B h(v h,φ)= F 1 φ dx, v h (3.4) a 2 t ψdx B h(u h,ψ)= F 2 ψdx E u

10 2140 ERIC T. CHUNG AND BJÖRN ENGQUIST for all φ U h and ψ V h, where B h (v h,φ)= (B φ)v h dx (3.5) (Lv h )[φ] d, (3.6) E 0 v Bh(u h,ψ)= (Bψ)u h dx + [Lψ]u h d. E u The initial conditions u h (0) and v h (0) will be defined as u h (0) = I u u 0 and v h (0) = I v v 0. We remark here that we define the spaces U h and V h so that (3.1) and (3.2) are valid. Furthermore, we define the discrete derivative operators B h and B h by B h ψ, φ = B h (ψ, φ) φ U h, Bhφ, ψ = Bh(φ, ψ) ψ V h. The two operators B h and Bh are the discrete analogue of the two derivative operators B and B. Lemma 3.1. For all φ U h and ψ V h, we have (3.7) B h (ψ, φ) =B h(φ, ψ). Proof. Let φ U h and ψ V h. Then, by the definition of B h and (3.1), B h (ψ, φ) = (B φ)v h dx (Lv h )[φ] d E 0 v = (B φ)ψ dx = ν N 1 ν N 1 S(ν) { (B φ)ψ dx S(ν) Using integration by parts on each triangle, B h (ψ, φ) = { φ(bψ) dx + ν N 1 S(ν) E u(ν) (Lψ)φ d S(ν) } (Lψ)φ d. } [Lψ]u d = Bh(φ, ψ). This completes the proof. We define the discrete L 2 norms and H 1 norms in the following ways. For all φ U h, we define φ 2 W = φ 2 dx + k+1 (3.8) φ(α j ) 2, (3.9) φ 2 Z = For all ψ V h, we define (3.10) ψ 2 W = (3.11) E u (h ) 2 j=1 (B φ) 2 dx + E v h 1 ψ 2 dx + E v h (Lψ) 2 d, [φ] 2 d. ψ 2 Z = (Bψ) 2 dx + (h ) 1 [Lψ] 2 d. E u

11 OPTIMAL DISCONTINUOUS GALERKIN METHODS 2141 With these definitions, we have the following continuity conditions for all φ U h and ψ V h : (3.12) B h (ψ, φ) K ψ W φ Z, (3.13) B h (ψ, φ) K ψ Z φ W. Moreover, we have, in U h, the norm φ W is equivalent to the standard L 2 norm φ, while in V h, the norm ψ W is equivalent to the standard L 2 norm ψ. That is, there are two uniform constants K 1 and K 2 such that (3.14) K 1 φ φ W K 2 φ φ U h, (3.15) K 1 ψ ψ W K 2 ψ ψ V h. Now, we will prove the following interpolation error estimates. The first one is the interpolation error in the discrete L 2 norms. Lemma 3.2. Assume (u, v) W k+1, () 3. Then for any integer m with 1 m k +1, (3.16) u I u u W Kh m u W m, (), v I v v W Kh m v W m, () 2. Proof. By the definition of W -norm and W -norm, u I u u W K u I u u L (), v I v v W K v I v v L () 2. The proof is complete by using (2.5) and (2.6). The second one is the interpolation error in the discrete H 1 norms. Lemma 3.3. Assume (u, v) H k+1 () 3. Then for any integer m with 1 m k, (3.17) u I u u Z Kh m u H m+1 (), v I v v Z Kh m v H m+1 () 2. Proof. Let I u u U h be the interpolant of u. By the definition of Z-norm, I u u u 2 Z = (B (I u u u)) 2 dx + (h ) 1 [I u u u] 2 d. The first term will be estimated by using the inverse inequality and the interpolation estimate (2.5) (B (I u u u)) 2 dx Kh 2k u 2 H k+1 (). E 0 v For the second term, we will use the trace inequality (I u u u) 2 d K( I u u u L 2 (R()) (I u u u) L 2 (R()) So, + h 1 I u u u 2 L 2 (R()) ). [I u u u] 2 d Kh 2k+1 u 2 H k+1 (), and this implies I u u u Z Kh k u H (). k+1 The estimate for v I v v Z can be proved by a similar argument.

12 2142 ERIC T. CHUNG AND BJÖRN ENGQUIST 4. Stability and convergence analysis. In this section, we will prove the stability and convergence of the scheme (3.3) (3.4). We write u, v = uv dx and u = u, u 1 2. In order to obtain an optimal error estimate, we will assume the following. The inf-sup conditions: (4.1) (4.2) inf ψ V h inf φ U h B h (ψ, φ) sup K, φ U h ψ Z φ W Bh (φ, ψ) sup K. ψ V h φ Z ψ W For a general introduction to this topic; see Brezzi and Fortin [2]. Consequently, we have (4.3) (4.4) B h ψ W K ψ Z, Bhφ W K φ Z. By the continuity conditions (3.12) and (3.13), we have (4.5) (4.6) K 1 ψ Z B h ψ W K 2 ψ Z, K 1 φ Z Bhφ W K 2 φ Z. So, the discrete H 1 norm is equivalent to the discrete L 2 norm of the discrete derivative operator. Notice that, the above two inf-sup conditions (4.3) (4.4) imply the existence of projection operators P v and P u such that (4.7) (4.8) B h (P v v v, φ) =0 φ U h, Bh(P u u u, ψ) =0 ψ V h. Regarding the initial condition u h (0) and v h (0), we can obtain them by solving the following: (4.9) (4.10) B h (P v v 0 v 0,φ)=0 φ U h, Bh(P u u 0 u 0,ψ)=0 ψ V h ; then set u h (0) = P u u 0 and v h (0) = P v v 0. However, in order to retain the accuracy of the approximation, the initial conditions can also be defined as u h (0) = I u u 0 and v h (0) = I v v 0, where I u and I v are some interpolation operators with the same order of accuracy and stability estimates u h (0) K u 0 and v h (0) K v 0. One important property of the numerical approximation (3.3) (3.4) is that energy is conserved, as is the case for the continuous problem (1.1) (1.2). In particular, the method (3.3) (3.4) is stable in the discrete L 2 norm. Moreover, the convergence in the L 2 norm is optimal. We state these results in the following theorem. Theorem 4.1. Let u U and v V be the solution to (1.1) (1.2) and let u h U h and v h V h be the solution to the numerical scheme (3.3) (3.4). Then, energy is conserved, namely (4.11) d ( u h 2 + v h 2 )=0.

13 OPTIMAL DISCONTINUOUS GALERKIN METHODS 2143 Moreover, for 0 t T, we have (u u h )(t) + (v v h )(t) { K inf u φ W + inf v ψ W (4.12) φ U h ψ V h t ( ) + inf u t φ W + inf v t ψ W φ U h ψ V h 0 } ds. Proof. Taking φ = u h and ψ = v h in (3.3) (3.4) yields duh a 1,u h + B h (v h,u h )=0, dvh a 2,v h Bh(u h,v h )=0. Adding the two equations and using (3.7), we obtain (4.11). In the following, we will prove (4.12). Let I u u and I v v be arbitrary elements in U h and V h, respectively. First, we have d(u uh ) (4.13) a 1,φ + B h (v v h,φ)=0 φ U h, d(v vh ) (4.14) a 2,ψ B h(u u h,ψ)=0 ψ V h. By the definitions of the projection operators P u and P v, we obtain d(u uh ) (4.15) a 1,φ + B h (P v v v h,φ)=0 φ U h, d(v vh ) (4.16) a 2,ψ B h(p u u u h,ψ)=0 ψ V h. Let Q 2 u : U h ker(bh ) and Q 2 v : V h ker(b h ) be the projection operators. Taking φ = Q 2 u(p u u u h ) and ψ = Q 2 v(p v v v h ), we have, by adding the two equations, d(u uh ) d(v a 1,Q 2 vh ) (4.17) u(p u u u h ) + a 2,Q 2 v(p v v v h ) =0, which implies d (a 1 Q 2 u(p u u u h ) 2 + a 2 Q 2 v(p v v v h ) 2 ) d(pu u u) = a 1,Q 2 u(p u u u h ) This can be rewritten as d (a 1 Q 2 u(p u u u h ) 2 + a 2 Q 2 v(p v v v h ) 2 ) d(pu u I u u) = a 1,Q 2 u(p u u u h ) d(iu u u) + a 1,Q 2 u(p u u u h ) d(pv v v) + a 2,Q 2 v(p v v v h ) + a 2 d(pv v I v v).,q 2 v(p v v v h ) d(iv v v) + a 2,Q 2 v(p v v v h ).

14 2144 ERIC T. CHUNG AND BJÖRN ENGQUIST Consequently, a 1 Q 2 u(p u u u h ) + a 2 Q 2 v(p v v v h ) t { } K Q 2 u(p u u t I u u t ) + Q 2 v(p v v t P v v t ) ds 0 t { } + K I u u t u t + I v v t v t ds. Using the triangle inequality, we finally have 0 a 1 Q 2 u(i u u u h ) + a 2 Q 2 v(i v v v h ) K( Q 2 u(p u u I u u) + Q 2 v(p v v I v v) ) t { } + K Q 2 u(p u u t I u u t ) + Q 2 v(p v v t P v v t ) ds 0 t { } + K I u u t u t + I v v t v t ds. 0 It suffices to estimate the norms Q 2 v(p v v I v v) and Q 2 u(p u u I u u). In particular, we will prove Q 2 v(p v v I v v) K v I v v W and Q 2 u(p u u I u u) K u I u u W. We consider the following variational problem: Given u 2 ker(b h ), find ψ V h such that (4.18) B h ( ψ, φ) = u 2,φ φ U h. The existence of ψ is ensured by the fact that Bh : V h ker(b h ) is surjective. Taking the supremum in φ and using (4.3), we derive the following estimate: (4.19) ψ Z K u 2. Now, we have Hence, we have Q 2 u(p u u I u u) 2 = B h ( ψ, Q 2 u(p u u I u u)) = Bh(Q 2 u(p u u I u u), ψ) = Bh(P u u I u u, ψ) = Bh(u I u u, ψ) ψ Z u I u u W K Q 2 u(p u u I u u) u I u u W. (4.20) Q 2 u(p u u I u u) u I u u W. Replacing u by u t,wehave (4.21) Q 2 u(p u u t I u u t ) u t I u u t W. Similarly, we consider the problem: Given v 2 ker(b h ), find φ U h such that (4.22) B h( φ, ψ) = v 2,ψ ψ V h

15 OPTIMAL DISCONTINUOUS GALERKIN METHODS 2145 with the estimate (4.23) φ Z K v 2. Hence, we have (4.24) Q 2 v(p v v I v v) v I v v W. Replacing v by v t,wehave (4.25) Q 2 v(p v v t I v v t ) v t I v v t W. This finishes the proof of estimates of the components of the errors in ker(bh ) and ker(b h ). In the following, we will estimate the components of errors in ker(bh ) and ker(b h ). Define Q 1 u : U h ker(bh ) and Q1 v : V h ker(b h ) as the orthogonal projection operators. Taking φ = Q 1 u(i u u u h ) and ψ = Q 1 v(i v v v h ), we have Hence, we obtain d(u uh ) a 1,Q 1 u(i u u u h ) d(v vh ) + a 2,Q 1 v(i v v v h ) =0. a 1 Q 1 u(i u u u h ) + a 2 Q 1 v(i v v v h ) Combining all results, I u u u h u + I v v v h v K The proof is complete by noticing that t u u h u I u u + I u u u h, v v h v I v v + I v v v h. 0 { } I u u t u t + I v v t v t ds. { Q 1 u(i u u u h ) u + Q 2 u(i u u u h ) u + Q 1 v(i v v v h ) v + Q 2 v(i v v v h ) v }. Now, we will state the convergence theorems. The following is the convergence in L 2 norm. We see that the numerical scheme is O(h k+1 ) when the FE spaces U h and V h contain polynomials of degree k. Corollary 4.2. Let (u, v) W 1,1 (0,T; W k+1, ()) 3 be the exact solution to the wave propagation problem (1.1) (1.2) and let (u h,v h ) be the solution to (3.3) (3.4). Then (4.26) u u h + v v h Kh k+1 ( u W 1,1 (0,T ;W k+1, ()) + v W 1,1 (0,T ;W k+1, ()) 2). Theorem 4.1 and Corollary 4.2 state that the numerical scheme (3.3) (3.4) is stable and convergent, with optimal rate, with respect to the discrete L 2 -norms. The L 2 stability can be satisfied by a very large class of spaces U h and V h. However, with L 2 stability only, it is not sufficient to deduce the weak convergence to the true solution;

16 2146 ERIC T. CHUNG AND BJÖRN ENGQUIST see Joly [11]. As a result, the numerical solution may behave badly and the optimal rate of convergence is not achieved. This fact can be seen by some numerical examples in the following sections. The extra conditions needed are the inf-sup conditions (4.1) (4.2), as many mixed FE methods require some compatibility conditions between the two spaces U h and V h. These conditions yield a stability in the discrete H 1 norm and we state this result in the following theorem. Theorem 4.3. Let u h U h and v h V h be the solution to the numerical scheme (3.3) (3.4). Then (4.27) { du 0 u h Z + v h Z K + dv 0 t + 0 ( df 1 ) + df 2 } ds. Proof. Taking t-derivative in (3.3) (3.4), we have d 2 ( ) u h a 1 2,φ dvh + B h,φ df1 =,φ d 2 ( ) v h a 2 2,ψ Bh duh,ψ df2 =,ψ φ U h, ψ V h. Taking φ = du h and ψ = dv h and adding the two equations, we obtain ( 1 d 2 du h a 1 dv h 2) 2 + a 2 df1 =, du h df2 +, dv h, and consequently { a du h 1 + dv h a 2 K du 0 + dv 0 t ( ) + df 1 + df 2 By using (4.3), v h Z B h (v h,φ) K B h v h W = K sup K sup φ U h φ W 0 φ U h duh } ds.,φ = K du h φ W. Similarly, we have u h Z K dv h. This completes the proof. Before we state the convergence theorem, we will state a L 2 convergence result which is very similar to Theorem 4.1 that all functions are replaced by their time derivative. It can be proved in exactly the same way as the proof of Theorem 4.1. Lemma 4.4. Let u U and v V be the solution to (1.1) (1.2) and let u h U h and v h V h be the solution to the numerical scheme (3.3) (3.4). Then for 0 t T, we have (4.28) { d (u u h)(t) + d (v v h)(t) K inf u t φ W + inf v t ψ W φ U h ψ V h t ( ) } + inf u tt φ W + inf v tt ψ W ds. φ U h ψ V h 0

17 OPTIMAL DISCONTINUOUS GALERKIN METHODS 2147 The following theorem states the convergence of the method (3.3) (3.4) in the discrete H 1 norm. It can be seen that the H 1 error is optimal with respect to the norms and the FE spaces. Theorem 4.5. Let u U and v V be the solution to (1.1) (1.2) and let u h U h and v h V h be the solution to the numerical scheme (3.3) (3.4). Then for 0 t T, we have ( ) d v v h Z K (u u (4.29) h) + inf ψ v Z, ψ V h ( ) d u u h Z K (v v (4.30) h) + inf φ u Z. φ U h Proof. By the inf-sup condition (4.3), we obtain P v v v h Z B h (P v v v h,φ) K B h (P v v v h ) W = K sup. φ U h φ W Recalling (4.15), we have d(u uh ),φ + B h (P v v v h,φ)=0 φ U h, and consequently, P v v v h Z K d (u u h). Let I v v V h be an arbitrary element of the FE space V h, using the triangle inequality v v h Z v I v v Z + I v v P v v Z + P v v v h Z. Following the proof of Theorem 4.1, we have I v v P v v Z K I v v v Z. Hence, we obtain v v h Z ( d K (u u h) + I vv v Z ). Since I v v is arbitrary, v v h Z ( d K (u u h) + inf ψ V h ψ v Z So, (4.29) is proved. The estimte (4.30) can be proved in a similar fashion. Now, we state and prove the convergence in the discrete H 1 norm. We see that the numerical scheme is O(h k ) in the discrete H 1 norm when the FE spaces U h and V h contain polynomials of degree k. Corollary 4.6. Assume k 0 is the largest integer such that U h and V h contain polynomials of degree k. Let (u, v) W 1,p (0,T; H k+1 ()) 3 W 2,p (0,T; W k, ()) 3, ).

18 2148 ERIC T. CHUNG AND BJÖRN ENGQUIST for p>1, be the exact solution to the wave propagation problem (1.1) (1.2), and let (u h,v h ) be the solution to the numerical scheme (3.3) (3.4). Then (4.31) u u h Z + v v h Z Kh k ( (u, v) W 1,p (0,T ;H k+1 ()) 3 + (u, v) W 2,p (0,T ;W k, ()) 3). Next, we prove a superconvergence result for some component of the derivative of u h. We state this result as the following theorem. Theorem 4.7. Let u be the exact solution to the wave propagation problem (1.1) (1.2) and let u h be the solution to the numerical method (3.3) (3.4). Then (4.32) L B (u u h ) L 2 () Kh k+1{ (u, v) W 2,1 (0,T ;W k+1, ()) 3 + u W 1,1 (0,T ;H k+2 ())}. Proof. To prove this, we observe that for all ψ V h a 2 t (v v h) ψdx Bh(u u h,ψ)=0. Let π h u be a function such that π h u isa(k + 1)th degree polynomial interpolant of u. Then we have Bh(u h π h u, ψ) =Bh(u π h u, ψ) a 2 t (v v h) ψ dx. Recalling the definition of Bh,wehave Bh(u h π h u, ψ) = B (u h π h u)ψ dx+ [u h π h u]lψ d. E u Now, we choose ψ V h such that Lψ = 0 and L ψ = L B (u h π h u). This is equivalent to sets (VD2) and (VD3) to being zero. Therefore, Bh(u h π h u, ψ) = (L B (u h π h u)) 2 dx, Consequently, we have ψ L 2 () = L B (u h π h u) L 2 (). L B (u h π h u) 2 L 2 () = (4.33) B h(u π h u, ψ) a 2 t (v v h) ψ dx. Now we will estimate the right-hand side of (4.33). By Lemma 4.4 and interpolation error estimates (3.16), the second term on the right-hand side of (4.33) can be estimated by t (v v h) Kh k+1 ( u W 2,1 (0,T ;W k+1, ()) + v W 2,1 (0,T ;W k+1, ()) 2). L 2 () Using inverse type inequalities, we have B (u π h u) L 2 () Kh k+1 u H k+2 (), ψ l L 2 () Kh 1 2 ψ L 2 ( ),

19 OPTIMAL DISCONTINUOUS GALERKIN METHODS 2149 and by the trace inequality, we obtain u π h u L2 () Kh k+ 3 2 u H k+2 (). Then the first term on the right-hand side of (4.33) can be estimated by B h(u π h u, ψ) B (u π h u) L 2 () ψ L 2 () + E u u π h u L 2 () Lψ L 2 () Kh k+1 u H k+2 () ψ L 2 (). Combining the result, we prove the theorem. Now, we will discuss the condition (1.4). In the following theorem, we show that the numerical solution v h satisfies (1.4) in a weak sense. Let S h be the space of standard H 1 -conforming FE space of degree k + 1, namely p S h if p P k+1 () and p is continuous across each E. Theorem 4.8. Let v be the exact solution of the wave propagation problem (1.1) (1.2) and let v h be the numerical solution to the numerical scheme (3.3) (3.4). Then (v v h ) (4.34) ψdx=0 t if and only if ψ = B p for p S h. Proof. If ψ = p for p S h, then ψ V h. Using (4.16), we have proved (4.34). Assume (4.34) holds. Then, using (4.16), we have Bh (P uu u h,ψ) = 0. By (4.3), we have ψ Z = 0. By the definition of Z -norm, we have Bψ = 0 and [Lψ] = 0 for all E u. Using Bψ = 0, we have ψ = B p for some p. Since ψ P k () 2,we have p P k+1 (). Notice that Lψ is continuous on each edge in Ev 0. Using this and [Lψ] = 0 for all E u, we have that p is continuous across each edge in E u Ev 0. So, the proof is complete. 5. Verification of inf-sup conditions. Now, we are in a position to prove that the choice of U h and V h above satisfies the inf-sup condition (4.1) (4.2). Theorem 5.1. There is a uniform constant K>0 such that (5.1) inf ψ V h Bh (u, ψ) sup u U h u W ψ Z K. Proof. Let ψ V h. It suffices to find u U h such that (5.2) B h(u, ψ) K ψ 2 Z and u K ψ Z. Recalling the definition of Bh,wehave Bh(u, ψ) = u(bψ) dx + [Lψ]u d. E u First, we will define u 1 U h such that (5.3) u 1 (Bψ) dx K (Bψ) 2 dx and (u 1 ) 2 dx (Bψ) 2 dx.

20 2150 ERIC T. CHUNG AND BJÖRN ENGQUIST Let T. We define the function u 1 such that u 1 = λ,2 λ,3 Bψ. Notice that Bψ P k 1 () and u 1 is zero on the two edges of that belong to E u,sou 1 R k (). Since λ,2 λ,3 1, the second equation in (5.3) holds. Notice that the quantity q2 k 1 λ,2λ,3 dx defines a norm for q k 1 in the space P k 1 (). Since norms in finite dimensional spaces are equivalent, we have λ,2 λ,3 (Bψ) 2 dx K (Bψ) 2 dx. Summing up this equation for all T proves the first equation in (5.3). Next, we will define u 2 U h such that [Lψ]u 2 d = (5.4) (h ) 1 [Lψ] 2 d, E u E u (u 2 ) 2 dx K (5.5) (h ) 1 [Lψ] 2 d. E u To do so, we define u 2 so that 1. u 2 =(h ) 1 [Lψ] atthek + 1 Gaussian points of for all E u, and 2. u 2q k 1 dx = 0 for all q k 1 P k 1 () and T. Then, clearly, (5.4) is satisfied. We will define a subspace Uh 0 of U h by { } Uh 0 = φ U h φq k 1 dx =0, q k 1 P k 1 (), T. Then the following quantity h 2 E u j=1 k+1 φ(α j ) 2 defines a norm for Uh 0. Since norms in finite dimensional spaces are equivalent, we have u 2 2 dx K k+1 u 2 (α j ) 2. By the definition of u 2, h 2 E u j=1 u 2 2 dx K k+1 [Lψ(α j )] 2. E u j=1 Since [Lψ] is a polynomial of degree k, wehave k+1 [Lψ(α j )] 2 K(h ) 1 [Lψ] 2 dx, j=1 which follows from norm equivalence in finite dimensional spaces. So, (5.5) is proved. To prove (5.2), we take u = u 1 + u 2. Notice that by the definitions of u 1 and u 2, we have u 2 (Bψ) dx = 0 and [Lψ]u 1 d =0.

21 OPTIMAL DISCONTINUOUS GALERKIN METHODS 2151 Using this together with (5.3), (5.4), and (5.5), we have proved (5.2). Theorem 5.2. There is a uniform constant K>0 such that (5.6) inf φ U h B h (v, φ) sup K. v V h v W φ Z Proof. Let φ U h. As in the proof of the previous theorem, we find v V h such that (5.7) B h (v, φ) K φ 2 Z and v K φ Z. Recalling the definition of B h,wehave B h (v, φ) = (B φ)v dx (Lv)[φ] d. Ev 0 We define v 1 V h such that (5.8) (B φ)v 1 dx K 1 B φ 2 dx and We define the set v 1 2 dx K B φ 2 dx. and the linear functional V 1 h () ={v v V h ; Lv =0 E v } f (η) = (B φ)η dx for η Vh 1(). With the standard L2 norm, Vh 1 () is a Hilbert space. By the Riesz representation theorem, there exist v 1, Vh 1 () such that f (η) = v 1, ηdx and v 1, L 2 () = f L 2 (), where denotes a norm in the dual space. That is, f L 2 () = sup f (η). η Vh 1() η L 2 () We define v 1 such that v 1 = v 1,. Then v 1 2 dx = v 1, 2 dx B φ 2 dx = B φ 2 dx, T T which proves the second inequality in (5.8). To prove the first inequality in (5.8), we will first show f L 2 () defines a norm for B U h on. So, it suffices to show B φ =0if f L 2 () = 0. Assume f L 2 () = 0. Then we have (B φ)η dx=0 for all η Vh 1(). Notice that B φ P k () 2. Taking Lη = 0 and L η = L (B φ) yields (L (B φ)) 2 dx = 0. So, we have L (B φ)=0on. By the definitions of L and B,wehave( λ,2 λ,3 )φ = 0. So, we have k+1 φ = c j (λ,2 + λ,3 ) j. j=0

22 2152 ERIC T. CHUNG AND BJÖRN ENGQUIST Since φ U h, we have c k+1 = 0 and therefore L(B φ) P k 1 (). Taking L η =0 and Lη = λ,1 L(B φ), we have λ,1(l(b φ)) 2 dx = 0, which implies L(B φ)=0. Hence B φ = 0. Since norms in finite dimensional spaces are equivalent, we have f L 2 () K B φ L 2 (). Consequently, we obtain (B φ)v 1 dx = (B φ)v 1, dx = f (v 1, )= v1, 2 dx, T T T which proves the first inequality in (5.8). We will find v 2 V h and a function v + such that (5.9) (L(v 2 + v + ))[φ] d K 2 (h ) 1 E v (5.10) E 0 v E 0 v [φ] 2 d, v 2 + v + 2 dx K 3 (h ) 1 [φ] 2 d. Let Ev 0 and let, be the two triangles sharing the same edge. We define Vh 2 ( ) as follows: V 2 h ( ) ={v + (λ,2 λ,3 q k ) v V h, (VD1)=(VD2)=0;q k P k ( )}. Here, by (VD1) = (VD2) = 0, we mean both the degrees of freedom defined by (VD1) and (VD2) are equal to zero. Also, the polynomial q k is fixed and will be chosen in the following. With the standard L 2 ( ) 2 norm, Vh 2 ( ) is a Hilbert space. We also define the following linear functional: g (η) = (Lη)[φ] d for all η Vh 2 ( ). By the Riesz representation theorem, there is an element v 2, + v + Vh 2 ( ) such that g (η) = (v 2, + v + )η dx and v 2, + v + L 2 ( ) 2 = g (L 2 ( ) 2 ), where the norm g (L 2 ( ) 2 ) is defined as g (L 2 ( ) 2 ) = sup g (η). η Vh 2( ) η L 2 ( ) 2 We then define v 2 by v 2 = v 2, and v + by v + = v +. Since (Lη)2 d K(h 1 η 2 dx, wehave g 2 (L 2 ( ) 2 ) 1 η 2 (Lη) 2 d [φ] 2 d Kh 1 [φ] 2 d. L 2 ( ) 2 Summing up all T proves (5.10). To prove (5.9), we will first show that [φ] = 0 if g (L 2 ( ) 2 ) = 0. Now, we assume g (L 2 ( ) 2 ) = 0. Then we have )

23 OPTIMAL DISCONTINUOUS GALERKIN METHODS 2153 (Lη)[φ] d = 0 for all η V h 2( ). We take η P k () 2 and η P k ( ) 2 such that Lη =[φ] atthek + 1 Gaussian points of. Then, η Vh 2 ( ) and w j [φ(α j )] 2 dx = (Lη)[φ] dx =0, h k+1 j=1 where the first equality follows from the Gaussian quadrature rule; here w j denotes the weight and α j denotes the quadrature point. Since the weights w j > 0, we have [φ] = 0 at the k + 1 Gaussian points of. Notice that [φ] is a polynomial of degree k + 1. So, we have that [φ] is a scalar multiple of the (k + 1)th degree Legendre polynomial, namely [φ] = bp k+1 for some constant b, where P k+1 is the Legendre polynomial of degree k + 1. We take η = (λ,2 λ,3 q k ) with q k to be determined below. Notice that Lη is the tangential derivative of λ,2 λ,3 q k along. By a change of variable, we have (Lη)[φ] d = d = d d dz ((1 z2 )q k (z))[φ(z)] dz d dz ((1 z2 )q k (z))bp k+1 (z) dz for some constant d>0. Notice that P k+1 satisfies the Legendre differential equation ( d (1 z 2 ) dp ) k+1 = (k + 1)(k +2)P k+1. dz dz So, we take q k = dp k+1 dz and extend the definition of q k over all of. Then we obtain 1 (Lη)[φ] dx = bd(k + 1)(k +2) P 2 k+1(z) dz. 1 This implies that b = 0. Hence [φ] = 0. So, g (L 2 ( ) 2 ) defines a norm on L2 (). Since norms in finite dimensional spaces are equivalent, we obtain A standard scale change argument yields g (L 2 ( ) 2 ) K( ) [φ] L 2 (). g (L2 ( ) 2 ) K(h ) 1 2 [φ] L2 (), which proves (5.9). Combining (5.8), (5.9), and (5.10), we have B h (δv 1 + v 2 + v +,φ) δk 1 B φ 2 dx + K 2 (h ) 1 [φ] 2 d E v + (B φ)(v 2 + v + ) dx. By the Cauchy Schwarz inequality, (B φ)(v 2 + v + ) dx K 2 v 2 + v + 2 dx K 3 B φ 2 dx. 2K 3 2K 2

24 2154 ERIC T. CHUNG AND BJÖRN ENGQUIST So, we have ( B h (δv 1 + v 2 + v +,φ) δk 1 K ) 3 B φ 2 dx + K 2 (h ) 1 [φ] 2 d. 2K 2 2 E v Now, we choose δ such that δk 1 K3 2K 2 B h (δv 1 + v 2 + v +,φ) min = 1. Then we have ( 1, K 2 2 ) φ 2 Z. Since B h (v +,φ)=0,wehave ( B h (δv 1 + v 2,φ) min 1, K ) 2 φ 2 2 Z. We take v = δv 1 + v 2 V h so that the first inequality in (5.7) is proved. To prove the second inequality in (5.7), we first notice that v 2, L 2 () defines a norm for Vh 2( ) since v 2, L 2 () = 0 implies (VD3) = 0 which in turn implies v 2, =0by unisolvence of the FE space V h. By norm equivalence in finite dimensional spaces, we have v 2, L 2 () Kh 1 2 v 2, L 2 () v 2, L 2 (). Then we obtain δv 1 + v 2 L 2 () δ v 1 L 2 () + v 2 L 2 () K v 1 L 2 () + h 1 2 v2 L 2 (). Furthermore, we have the following orthogonality condition: 1 ( v 2, v + d d = v 2, (1 z 2 ) dp ) k+1 dz dz dz 1 = (k + 1)(k +2) 1 1 v 2, P k+1 dz =0 since the function P k+1 is equal to zero at the k + 1 Gaussian points of. By the orthogonality condition, v 2 2 L 2 () v 2 2 L 2 () + v+ 2 L 2 () = v 2 + v + 2 L 2 () Kh 1 v 2 + v + 2 L 2 ( ), where the last inequality follows from trace inequality. So, we have δv 1 + v 2 L 2 ( ) 2 K v 1 L 2 ( ) 2 + K v 2 + v + L 2 ( ) 2. Summing up all T and using estimates (5.8) and (5.10) completes the proof. 6. Numerical examples. In this section we present a series of numerical experiments which give quantitative results and confirm the rate of convergence of the method (3.3) (3.4). We will, in particular, consider the TE mode of Maxwell s equations (E) and set = [0, 2π] 2, a 1 = a 2 = 1, and F 1 = F 2 = 0. In addition, the function u is the magnetic field H while the vector v is the electric field E. The exact solution to Maxwell s equations is H(x, t) = cos(t) cos(x 1 ) + cos(t) cos(x 2 ), E 1 (x, t) = sin(t) sin(x 2 ), E 2 (x, t) = sin(t) sin(x 1 ).

25 OPTIMAL DISCONTINUOUS GALERKIN METHODS 2155 Table 6.1 L 2 norm errors at T = π/4 for k =0. Rate of convergence is N NT L 2 error Table 6.2 Errors in various norms at T = π/4 for k =1. N NT L 2 error H H h Z E E h Z The domain is triangulated in the following manner. First, we divide into N N uniform squares. Then, we subdivide each square by connecting the lower left corner and the upper right corner to obtain two triangles. We further subdivide each triangle into three triangles by connecting the center of the triangle to its three vertices. For the resulting ODE system in time, we use the standard leap-frog scheme. Below we use NT to represent the number of time steps. We first consider an example for the first order method, that is, k = 0. We then test the rate of convergence by comparing the solution to the scheme (3.3) (3.4) and the exact solution at T = π 4. Table 6.1 shows the discrete L2 errors for various mesh sizes, from N =10toN = 320. Here, we choose the time step small enough so that a suitable CFL condition for the leap-frog scheme is satisfied. We will use the results from Table 6.1 and the least squares method to estimate the rates of convergence of the scheme in the discrete L 2 norm. More precisely, we assume the error is proportional to h β for some β R, and then perform a least square data fitting using the data from Table 6.1. Doing this, the numerical rate of convergence is This confirms that the scheme is first order convergence in the discrete L 2 norm. Next, we consider an example with k = 1, that is, the FE spaces U h and V h, which contain all linear polynomials and a subset of quadratic polynomials. We will test the rates of convergence in various norms at T = π/4. Table 6.2 shows the results of error in various norms with various mesh sizes. In the third column of Table 6.2, we give the sum of the error for both H and E in the discrete L 2 norm. In the fourth column, we have the error for the magnetic field in the Z-norm. In the fifth column, we have the error for the electric field in the Z -norm. Table 6.3 shows the estimated rates of convergence. From the table, we see that the estimated rate of convergence in the discrete L 2 norm is approximately 2. Moreover, the estimated rates of convergence in H 1 semi-norms are approximately equal to 1. Our theoretical statements are thus confirmed by this experiment. In Table 6.4, we also show the error for the divergence of E as well as the normal jump of E. We have not proved convergence results in these two norms, but they are implied by the estimates that we proved in previous sections. The error in the

26 2156 ERIC T. CHUNG AND BJÖRN ENGQUIST Table 6.3 Estimated rate of convergence at T = π/4 for k =1. Norm Estimated rate L 2 norm H H h Z E E h Z N Table 6.4 Normal jump and divergence errors at T = π/4 for k =1. NT E (h 1 2 ) L (E E h ) L 2 () div(e E h ) L 2 () divergence of E is measured by div(e E h ) L 2 () while the error in the normal jump of E is measured by 1 E (h 2 ) L (E E h ) L 2 (). The estimated rates in both norms are and 1.040, respectively. So, the rates of convergence are indeed first order for these two norms. In what follows, we will consider the one dimensional scalar wave equation on =[0, 2π], u t = v x, v t = u x, with periodic boundary condition. The purpose is to compare our new optimal DG with the central DG method. The central DG method is typically based on piecewise polynomial approximation without continuity requirement across cell interfaces. Flux integrals along cell boundaries are evaluated by using the average of two values of the numerical solutions from the two neighboring cells, or the so called central numerical flux; see, for example, [7]. We choose u(x, t) =e sin(x t) and v(x, t) = e sin(x t) to be the exact solution. We will compare the numerical solutions by the two methods at T = 20 using 20 spatial cells and the leap-frog scheme for the time discretization. Figure 6.1 shows the numerical solutions. First, we see that both methods preserve energy. Second, we see that there are spurious modes in the numerical solutions obtained by the central DG. It can be shown that the central DG does not satisfy the inf-sup conditions that we introduce in this paper. With our new optimal DG, which verifies the inf-sup conditions, we see that there is no spurious mode appearing in the numerical solution. Now we will compare our new DG with an upwind DG method. The upwind DG method is typically based on piecewise polynomial approximation without continuity requirement. Flux integrals along cell boundaries are evaluated by taking the upwind value of the numerical solution from the two neighboring cells, or the so called upwind numerical flux; see, for example, [10]. We will compare the numerical solutions by both methods using the same setting except that T = 100 and the 4th order Runge Kutta method is used for time stepping for the upwind DG. Figure 6.2 shows the numerical results. We see that both methods contain no spurious mode. For the

A local-structure-preserving local discontinuous Galerkin method for the Laplace equation

A local-structure-preserving local discontinuous Galerkin method for the Laplace equation A local-structure-preserving local discontinuous Galerkin method for the Laplace equation Fengyan Li 1 and Chi-Wang Shu 2 Abstract In this paper, we present a local-structure-preserving local discontinuous

More information

Discontinuous Galerkin and Finite Difference Methods for the Acoustic Equations with Smooth Coefficients. Mario Bencomo TRIP Review Meeting 2013

Discontinuous Galerkin and Finite Difference Methods for the Acoustic Equations with Smooth Coefficients. Mario Bencomo TRIP Review Meeting 2013 About Me Mario Bencomo Currently 2 nd year graduate student in CAAM department at Rice University. B.S. in Physics and Applied Mathematics (Dec. 2010). Undergraduate University: University of Texas at

More information

Variational Formulations

Variational Formulations Chapter 2 Variational Formulations In this chapter we will derive a variational (or weak) formulation of the elliptic boundary value problem (1.4). We will discuss all fundamental theoretical results that

More information

Discontinuous Galerkin Methods

Discontinuous Galerkin Methods Discontinuous Galerkin Methods Joachim Schöberl May 20, 206 Discontinuous Galerkin (DG) methods approximate the solution with piecewise functions (polynomials), which are discontinuous across element interfaces.

More information

Scientific Computing WS 2018/2019. Lecture 15. Jürgen Fuhrmann Lecture 15 Slide 1

Scientific Computing WS 2018/2019. Lecture 15. Jürgen Fuhrmann Lecture 15 Slide 1 Scientific Computing WS 2018/2019 Lecture 15 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 15 Slide 1 Lecture 15 Slide 2 Problems with strong formulation Writing the PDE with divergence and gradient

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

Local discontinuous Galerkin methods for elliptic problems

Local discontinuous Galerkin methods for elliptic problems COMMUNICATIONS IN NUMERICAL METHODS IN ENGINEERING Commun. Numer. Meth. Engng 2002; 18:69 75 [Version: 2000/03/22 v1.0] Local discontinuous Galerkin methods for elliptic problems P. Castillo 1 B. Cockburn

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

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 The Residual and Error of Finite Element Solutions Mixed BVP of Poisson Equation

More information

A WEAK GALERKIN MIXED FINITE ELEMENT METHOD FOR BIHARMONIC EQUATIONS

A WEAK GALERKIN MIXED FINITE ELEMENT METHOD FOR BIHARMONIC EQUATIONS A WEAK GALERKIN MIXED FINITE ELEMENT METHOD FOR BIHARMONIC EQUATIONS LIN MU, JUNPING WANG, YANQIU WANG, AND XIU YE Abstract. This article introduces and analyzes a weak Galerkin mixed finite element method

More information

Basic Principles of Weak Galerkin Finite Element Methods for PDEs

Basic Principles of Weak Galerkin Finite Element Methods for PDEs Basic Principles of Weak Galerkin Finite Element Methods for PDEs Junping Wang Computational Mathematics Division of Mathematical Sciences National Science Foundation Arlington, VA 22230 Polytopal Element

More information

New class of finite element methods: weak Galerkin methods

New class of finite element methods: weak Galerkin methods New class of finite element methods: weak Galerkin methods Xiu Ye University of Arkansas at Little Rock Second order elliptic equation Consider second order elliptic problem: a u = f, in Ω (1) u = 0, on

More information

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1 Scientific Computing WS 2017/2018 Lecture 18 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 18 Slide 1 Lecture 18 Slide 2 Weak formulation of homogeneous Dirichlet problem Search u H0 1 (Ω) (here,

More information

ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS

ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS CARLO LOVADINA AND ROLF STENBERG Abstract The paper deals with the a-posteriori error analysis of mixed finite element methods

More information

Nedelec elements for computational electromagnetics

Nedelec elements for computational electromagnetics Nedelec elements for computational electromagnetics Per Jacobsson, June 5, 2007 Maxwell s equations E = jωµh () H = jωεe + J (2) (εe) = ρ (3) (µh) = 0 (4) J = jωρ (5) Only three of the equations are needed,

More information

b i (x) u + c(x)u = f in Ω,

b i (x) u + c(x)u = f in Ω, SIAM J. NUMER. ANAL. Vol. 39, No. 6, pp. 1938 1953 c 2002 Society for Industrial and Applied Mathematics SUBOPTIMAL AND OPTIMAL CONVERGENCE IN MIXED FINITE ELEMENT METHODS ALAN DEMLOW Abstract. An elliptic

More information

Numerical Analysis of Higher Order Discontinuous Galerkin Finite Element Methods

Numerical Analysis of Higher Order Discontinuous Galerkin Finite Element Methods Numerical Analysis of Higher Order Discontinuous Galerkin Finite Element Methods Contents Ralf Hartmann Institute of Aerodynamics and Flow Technology DLR (German Aerospace Center) Lilienthalplatz 7, 3808

More information

Chapter 1: The Finite Element Method

Chapter 1: The Finite Element Method Chapter 1: The Finite Element Method Michael Hanke Read: Strang, p 428 436 A Model Problem Mathematical Models, Analysis and Simulation, Part Applications: u = fx), < x < 1 u) = u1) = D) axial deformation

More information

Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions

Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions Bernhard Hientzsch Courant Institute of Mathematical Sciences, New York University, 51 Mercer Street, New

More information

Numerische Mathematik

Numerische Mathematik Numer. Math. (2012) 122:61 99 DOI 10.1007/s00211-012-0456-x Numerische Mathematik C 0 elements for generalized indefinite Maxwell equations Huoyuan Duan Ping Lin Roger C. E. Tan Received: 31 July 2010

More information

A Neumann series based method for photoacoustic tomography on irregular domains

A Neumann series based method for photoacoustic tomography on irregular domains A Neumann series based method for photoacoustic tomography on irregular domains Eric Chung, Chi Yeung Lam, and Jianliang Qian Abstract. Recently, a Neumann series based numerical method is developed for

More information

A staggered discontinuous Galerkin method for the simulation of. Rayleigh waves

A staggered discontinuous Galerkin method for the simulation of. Rayleigh waves A staggered discontinuous Galerkin method for the simulation of Rayleigh waves Eric T. Chung ; Chi Yeung Lam ; Jianliang Qian Department of Mathematics The Chinese University of Hong Kong, Hong Kong SAR.

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

Chapter 5 A priori error estimates for nonconforming finite element approximations 5.1 Strang s first lemma

Chapter 5 A priori error estimates for nonconforming finite element approximations 5.1 Strang s first lemma Chapter 5 A priori error estimates for nonconforming finite element approximations 51 Strang s first lemma We consider the variational equation (51 a(u, v = l(v, v V H 1 (Ω, and assume that the conditions

More information

Controllability of the linear 1D wave equation with inner moving for

Controllability of the linear 1D wave equation with inner moving for Controllability of the linear D wave equation with inner moving forces ARNAUD MÜNCH Université Blaise Pascal - Clermont-Ferrand - France Toulouse, May 7, 4 joint work with CARLOS CASTRO (Madrid) and NICOLAE

More information

Superconvergence of discontinuous Galerkin methods for 1-D linear hyperbolic equations with degenerate variable coefficients

Superconvergence of discontinuous Galerkin methods for 1-D linear hyperbolic equations with degenerate variable coefficients Superconvergence of discontinuous Galerkin methods for -D linear hyperbolic equations with degenerate variable coefficients Waixiang Cao Chi-Wang Shu Zhimin Zhang Abstract In this paper, we study the superconvergence

More information

The Discontinuous Galerkin Method for Hyperbolic Problems

The Discontinuous Galerkin Method for Hyperbolic Problems Chapter 2 The Discontinuous Galerkin Method for Hyperbolic Problems In this chapter we shall specify the types of problems we consider, introduce most of our notation, and recall some theory on the DG

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

ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS

ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS MATHEMATICS OF COMPUTATION Volume 75, Number 256, October 2006, Pages 1659 1674 S 0025-57180601872-2 Article electronically published on June 26, 2006 ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED

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 Nonconformity and the Consistency Error First Strang Lemma Abstract Error Estimate

More information

An Equal-order DG Method for the Incompressible Navier-Stokes Equations

An Equal-order DG Method for the Incompressible Navier-Stokes Equations An Equal-order DG Method for the Incompressible Navier-Stokes Equations Bernardo Cockburn Guido anschat Dominik Schötzau Journal of Scientific Computing, vol. 40, pp. 188 10, 009 Abstract We introduce

More information

INTRODUCTION TO FINITE ELEMENT METHODS

INTRODUCTION TO FINITE ELEMENT METHODS INTRODUCTION TO FINITE ELEMENT METHODS LONG CHEN Finite element methods are based on the variational formulation of partial differential equations which only need to compute the gradient of a function.

More information

HIGH ORDER NUMERICAL METHODS FOR TIME DEPENDENT HAMILTON-JACOBI EQUATIONS

HIGH ORDER NUMERICAL METHODS FOR TIME DEPENDENT HAMILTON-JACOBI EQUATIONS June 6, 7 :7 WSPC/Lecture Notes Series: 9in x 6in chapter HIGH ORDER NUMERICAL METHODS FOR TIME DEPENDENT HAMILTON-JACOBI EQUATIONS Chi-Wang Shu Division of Applied Mathematics, Brown University Providence,

More information

arxiv: v1 [math.na] 19 Nov 2018

arxiv: v1 [math.na] 19 Nov 2018 QUASINORMS IN SEMILINEAR ELLIPTIC PROBLEMS JAMES JACKAMAN AND TRISTAN PRYER arxiv:1811.07816v1 [math.na] 19 Nov 2018 (1.1) Abstract. In this note we examine the a priori and a posteriori analysis of discontinuous

More information

NONCONFORMING MIXED ELEMENTS FOR ELASTICITY

NONCONFORMING MIXED ELEMENTS FOR ELASTICITY Mathematical Models and Methods in Applied Sciences Vol. 13, No. 3 (2003) 295 307 c World Scientific Publishing Company NONCONFORMING MIXED ELEMENTS FOR ELASTICITY DOUGLAS N. ARNOLD Institute for Mathematics

More information

A posteriori error estimation for elliptic problems

A posteriori error estimation for elliptic problems A posteriori error estimation for elliptic problems Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in

More information

Key words. Incompressible magnetohydrodynamics, mixed finite element methods, discontinuous Galerkin methods

Key words. Incompressible magnetohydrodynamics, mixed finite element methods, discontinuous Galerkin methods A MIXED DG METHOD FOR LINEARIZED INCOMPRESSIBLE MAGNETOHYDRODYNAMICS PAUL HOUSTON, DOMINIK SCHÖTZAU, AND XIAOXI WEI Journal of Scientific Computing, vol. 40, pp. 8 34, 009 Abstract. We introduce and analyze

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

Discontinuous Galerkin Methods: Theory, Computation and Applications

Discontinuous Galerkin Methods: Theory, Computation and Applications Discontinuous Galerkin Methods: Theory, Computation and Applications Paola. Antonietti MOX, Dipartimento di Matematica Politecnico di Milano.MO. X MODELLISTICA E CALCOLO SCIENTIICO. MODELING AND SCIENTIIC

More information

INF-SUP CONDITION FOR OPERATOR EQUATIONS

INF-SUP CONDITION FOR OPERATOR EQUATIONS INF-SUP CONDITION FOR OPERATOR EQUATIONS LONG CHEN We study the well-posedness of the operator equation (1) T u = f. where T is a linear and bounded operator between two linear vector spaces. We give equivalent

More information

Adaptive Finite Element Methods Lecture Notes Winter Term 2017/18. R. Verfürth. Fakultät für Mathematik, Ruhr-Universität Bochum

Adaptive Finite Element Methods Lecture Notes Winter Term 2017/18. R. Verfürth. Fakultät für Mathematik, Ruhr-Universität Bochum Adaptive Finite Element Methods Lecture Notes Winter Term 2017/18 R. Verfürth Fakultät für Mathematik, Ruhr-Universität Bochum Contents Chapter I. Introduction 7 I.1. Motivation 7 I.2. Sobolev and finite

More information

A Mixed Nonconforming Finite Element for Linear Elasticity

A Mixed Nonconforming Finite Element for Linear Elasticity A Mixed Nonconforming Finite Element for Linear Elasticity Zhiqiang Cai, 1 Xiu Ye 2 1 Department of Mathematics, Purdue University, West Lafayette, Indiana 47907-1395 2 Department of Mathematics and Statistics,

More information

LECTURE 1: SOURCES OF ERRORS MATHEMATICAL TOOLS A PRIORI ERROR ESTIMATES. Sergey Korotov,

LECTURE 1: SOURCES OF ERRORS MATHEMATICAL TOOLS A PRIORI ERROR ESTIMATES. Sergey Korotov, LECTURE 1: SOURCES OF ERRORS MATHEMATICAL TOOLS A PRIORI ERROR ESTIMATES Sergey Korotov, Institute of Mathematics Helsinki University of Technology, Finland Academy of Finland 1 Main Problem in Mathematical

More information

1. Introduction. We consider the model problem that seeks an unknown function u = u(x) satisfying

1. Introduction. We consider the model problem that seeks an unknown function u = u(x) satisfying A SIMPLE FINITE ELEMENT METHOD FOR LINEAR HYPERBOLIC PROBLEMS LIN MU AND XIU YE Abstract. In this paper, we introduce a simple finite element method for solving first order hyperbolic equations with easy

More information

ICES REPORT A Generalized Mimetic Finite Difference Method and Two-Point Flux Schemes over Voronoi Diagrams

ICES REPORT A Generalized Mimetic Finite Difference Method and Two-Point Flux Schemes over Voronoi Diagrams ICS RPORT 15-17 July 2015 A Generalized Mimetic Finite Difference Method and Two-Point Flux Schemes over Voronoi Diagrams by Omar Al-Hinai, Mary F. Wheeler, Ivan Yotov The Institute for Computational ngineering

More information

arxiv: v3 [math.na] 8 Sep 2015

arxiv: v3 [math.na] 8 Sep 2015 A Recovery-Based A Posteriori Error Estimator for H(curl) Interface Problems arxiv:504.00898v3 [math.na] 8 Sep 205 Zhiqiang Cai Shuhao Cao Abstract This paper introduces a new recovery-based a posteriori

More information

Basic Concepts of Adaptive Finite Element Methods for Elliptic Boundary Value Problems

Basic Concepts of Adaptive Finite Element Methods for Elliptic Boundary Value Problems Basic Concepts of Adaptive Finite lement Methods for lliptic Boundary Value Problems Ronald H.W. Hoppe 1,2 1 Department of Mathematics, University of Houston 2 Institute of Mathematics, University of Augsburg

More information

Numerical Methods for Partial Differential Equations

Numerical Methods for Partial Differential Equations Numerical Methods for Partial Differential Equations CAAM 45 Spring 005 Lecture 15 Instructor: Tim Warburton Two-Dimensional Advection Recall in one-dimensions we chose an arbitrary section of a pipe.

More information

High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation

High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation Faheem Ahmed, Fareed Ahmed, Yongheng Guo, Yong Yang Abstract This paper deals with

More information

A posteriori error estimates for non conforming approximation of eigenvalue problems

A posteriori error estimates for non conforming approximation of eigenvalue problems A posteriori error estimates for non conforming approximation of eigenvalue problems E. Dari a, R. G. Durán b and C. Padra c, a Centro Atómico Bariloche, Comisión Nacional de Energía Atómica and CONICE,

More information

Energy norm a-posteriori error estimation for divergence-free discontinuous Galerkin approximations of the Navier-Stokes equations

Energy norm a-posteriori error estimation for divergence-free discontinuous Galerkin approximations of the Navier-Stokes equations INTRNATIONAL JOURNAL FOR NUMRICAL MTHODS IN FLUIDS Int. J. Numer. Meth. Fluids 19007; 1:1 [Version: 00/09/18 v1.01] nergy norm a-posteriori error estimation for divergence-free discontinuous Galerkin approximations

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

IMPROVED LEAST-SQUARES ERROR ESTIMATES FOR SCALAR HYPERBOLIC PROBLEMS, 1

IMPROVED LEAST-SQUARES ERROR ESTIMATES FOR SCALAR HYPERBOLIC PROBLEMS, 1 Computational Methods in Applied Mathematics Vol. 1, No. 1(2001) 1 8 c Institute of Mathematics IMPROVED LEAST-SQUARES ERROR ESTIMATES FOR SCALAR HYPERBOLIC PROBLEMS, 1 P.B. BOCHEV E-mail: bochev@uta.edu

More information

A FV Scheme for Maxwell s equations

A FV Scheme for Maxwell s equations A FV Scheme for Maxwell s equations Convergence Analysis on unstructured meshes Stephanie Lohrengel * Malika Remaki ** *Laboratoire J.A. Dieudonné (UMR CNRS 6621), Université de Nice Sophia Antipolis,

More information

Yongdeok Kim and Seki Kim

Yongdeok Kim and Seki Kim J. Korean Math. Soc. 39 (00), No. 3, pp. 363 376 STABLE LOW ORDER NONCONFORMING QUADRILATERAL FINITE ELEMENTS FOR THE STOKES PROBLEM Yongdeok Kim and Seki Kim Abstract. Stability result is obtained for

More information

Finite Elements. Colin Cotter. February 22, Colin Cotter FEM

Finite Elements. Colin Cotter. February 22, Colin Cotter FEM Finite Elements February 22, 2019 In the previous sections, we introduced the concept of finite element spaces, which contain certain functions defined on a domain. Finite element spaces are examples of

More information

Chapter 3 Conforming Finite Element Methods 3.1 Foundations Ritz-Galerkin Method

Chapter 3 Conforming Finite Element Methods 3.1 Foundations Ritz-Galerkin Method Chapter 3 Conforming Finite Element Methods 3.1 Foundations 3.1.1 Ritz-Galerkin Method Let V be a Hilbert space, a(, ) : V V lr a bounded, V-elliptic bilinear form and l : V lr a bounded linear functional.

More information

Numerische Mathematik

Numerische Mathematik Numer. Math. (2003) 94: 195 202 Digital Object Identifier (DOI) 10.1007/s002110100308 Numerische Mathematik Some observations on Babuška and Brezzi theories Jinchao Xu, Ludmil Zikatanov Department of Mathematics,

More information

1 Constrained Optimization

1 Constrained Optimization 1 Constrained Optimization Let B be an M N matrix, a linear operator from the space IR N to IR M with adjoint B T. For (column vectors) x IR N and y IR M we have x B T y = Bx y. This vanishes for all y

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

Local flux mimetic finite difference methods

Local flux mimetic finite difference methods Local flux mimetic finite difference methods Konstantin Lipnikov Mikhail Shashkov Ivan Yotov November 4, 2005 Abstract We develop a local flux mimetic finite difference method for second order elliptic

More information

Basics and some applications of the mortar element method

Basics and some applications of the mortar element method GAMM-Mitt. 28, No. 2, 97 123 (2005) Basics and some applications of the mortar element method Christine Bernardi 1, Yvon Maday 1, and Francesca Rapetti 2 1 Laboratoire Jacques-Louis Lions, C.N.R.S. & université

More information

DG discretization of optimized Schwarz methods for Maxwell s equations

DG discretization of optimized Schwarz methods for Maxwell s equations DG discretization of optimized Schwarz methods for Maxwell s equations Mohamed El Bouajaji, Victorita Dolean,3, Martin J. Gander 3, Stéphane Lanteri, and Ronan Perrussel 4 Introduction In the last decades,

More information

Scientific Computing I

Scientific Computing I Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Neckel Winter 2013/2014 Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 1 Part I: Introduction to

More information

AMS subject classifications. Primary, 65N15, 65N30, 76D07; Secondary, 35B45, 35J50

AMS subject classifications. Primary, 65N15, 65N30, 76D07; Secondary, 35B45, 35J50 A SIMPLE FINITE ELEMENT METHOD FOR THE STOKES EQUATIONS LIN MU AND XIU YE Abstract. The goal of this paper is to introduce a simple finite element method to solve the Stokes equations. This method is in

More information

The CG1-DG2 method for conservation laws

The CG1-DG2 method for conservation laws for conservation laws Melanie Bittl 1, Dmitri Kuzmin 1, Roland Becker 2 MoST 2014, Germany 1 Dortmund University of Technology, Germany, 2 University of Pau, France CG1-DG2 Method - Motivation hp-adaptivity

More information

Hybridized DG methods

Hybridized DG methods Hybridized DG methods University of Florida (Banff International Research Station, November 2007.) Collaborators: Bernardo Cockburn University of Minnesota Raytcho Lazarov Texas A&M University Thanks:

More information

DISCONTINUOUS GALERKIN FINITE ELEMENT METHOD FOR THE WAVE EQUATION. SIAM J. Numer. Anal., Vol. 44, pp , 2006

DISCONTINUOUS GALERKIN FINITE ELEMENT METHOD FOR THE WAVE EQUATION. SIAM J. Numer. Anal., Vol. 44, pp , 2006 DISCONTINUOUS GALERIN INITE ELEMENT METHOD OR THE WAVE EQUATION MARCUS J. GROTE, ANNA SCHNEEBELI, AND DOMINI SCHÖTZAU SIAM J. Numer. Anal., Vol. 44, pp. 408-43, 006 Abstract. The symmetric interior penalty

More information

Hamburger Beiträge zur Angewandten Mathematik

Hamburger Beiträge zur Angewandten Mathematik Hamburger Beiträge zur Angewandten Mathematik Numerical analysis of a control and state constrained elliptic control problem with piecewise constant control approximations Klaus Deckelnick and Michael

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

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

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

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

QUADRILATERAL H(DIV) FINITE ELEMENTS

QUADRILATERAL H(DIV) FINITE ELEMENTS QUADRILATERAL H(DIV) FINITE ELEMENTS DOUGLAS N. ARNOLD, DANIELE BOFFI, AND RICHARD S. FALK Abstract. We consider the approximation properties of quadrilateral finite element spaces of vector fields defined

More information

Weak Galerkin Finite Element Scheme and Its Applications

Weak Galerkin Finite Element Scheme and Its Applications Weak Galerkin Finite Element Scheme and Its Applications Ran Zhang Department of Mathematics Jilin University, China IMS, Singapore February 6, 2015 Talk Outline Motivation WG FEMs: Weak Operators + Stabilizer

More information

Math 660-Lecture 15: Finite element spaces (I)

Math 660-Lecture 15: Finite element spaces (I) Math 660-Lecture 15: Finite element spaces (I) (Chapter 3, 4.2, 4.3) Before we introduce the concrete spaces, let s first of all introduce the following important lemma. Theorem 1. Let V h consists of

More information

Superconvergence of the Direct Discontinuous Galerkin Method for Convection-Diffusion Equations

Superconvergence of the Direct Discontinuous Galerkin Method for Convection-Diffusion Equations Superconvergence of the Direct Discontinuous Galerkin Method for Convection-Diffusion Equations Waixiang Cao, Hailiang Liu, Zhimin Zhang,3 Division of Applied and Computational Mathematics, Beijing Computational

More information

On an Approximation Result for Piecewise Polynomial Functions. O. Karakashian

On an Approximation Result for Piecewise Polynomial Functions. O. Karakashian BULLETIN OF THE GREE MATHEMATICAL SOCIETY Volume 57, 010 (1 7) On an Approximation Result for Piecewise Polynomial Functions O. arakashian Abstract We provide a new approach for proving approximation results

More information

1. Introduction. The Stokes problem seeks unknown functions u and p satisfying

1. Introduction. The Stokes problem seeks unknown functions u and p satisfying A DISCRETE DIVERGENCE FREE WEAK GALERKIN FINITE ELEMENT METHOD FOR THE STOKES EQUATIONS LIN MU, JUNPING WANG, AND XIU YE Abstract. A discrete divergence free weak Galerkin finite element method is developed

More information

WEAK GALERKIN FINITE ELEMENT METHODS ON POLYTOPAL MESHES

WEAK GALERKIN FINITE ELEMENT METHODS ON POLYTOPAL MESHES INERNAIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume 12, Number 1, Pages 31 53 c 2015 Institute for Scientific Computing and Information WEAK GALERKIN FINIE ELEMEN MEHODS ON POLYOPAL MESHES LIN

More information

On Dual-Weighted Residual Error Estimates for p-dependent Discretizations

On Dual-Weighted Residual Error Estimates for p-dependent Discretizations On Dual-Weighted Residual Error Estimates for p-dependent Discretizations Aerospace Computational Design Laboratory Report TR-11-1 Masayuki Yano and David L. Darmofal September 21, 2011 Abstract This report

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

A gradient recovery method based on an oblique projection and boundary modification

A gradient recovery method based on an oblique projection and boundary modification ANZIAM J. 58 (CTAC2016) pp.c34 C45, 2017 C34 A gradient recovery method based on an oblique projection and boundary modification M. Ilyas 1 B. P. Lamichhane 2 M. H. Meylan 3 (Received 24 January 2017;

More information

BUBBLE STABILIZED DISCONTINUOUS GALERKIN METHOD FOR STOKES PROBLEM

BUBBLE STABILIZED DISCONTINUOUS GALERKIN METHOD FOR STOKES PROBLEM BUBBLE STABILIZED DISCONTINUOUS GALERKIN METHOD FOR STOKES PROBLEM ERIK BURMAN AND BENJAMIN STAMM Abstract. We propose a low order discontinuous Galerkin method for incompressible flows. Stability of the

More information

Chapter 1. Introduction and Background. 1.1 Introduction

Chapter 1. Introduction and Background. 1.1 Introduction Chapter 1 Introduction and Background 1.1 Introduction Over the past several years the numerical approximation of partial differential equations (PDEs) has made important progress because of the rapid

More information

Overlapping Schwarz Preconditioners for Spectral. Problem in H(curl)

Overlapping Schwarz Preconditioners for Spectral. Problem in H(curl) Overlapping Schwarz Preconditioners for Spectral Nédélec Elements for a Model Problem in H(curl) Technical Report TR2002-83 November 22, 2002 Department of Computer Science Courant Institute of Mathematical

More information

Vector spaces. DS-GA 1013 / MATH-GA 2824 Optimization-based Data Analysis.

Vector spaces. DS-GA 1013 / MATH-GA 2824 Optimization-based Data Analysis. Vector spaces DS-GA 1013 / MATH-GA 2824 Optimization-based Data Analysis http://www.cims.nyu.edu/~cfgranda/pages/obda_fall17/index.html Carlos Fernandez-Granda Vector space Consists of: A set V A scalar

More information

A DELTA-REGULARIZATION FINITE ELEMENT METHOD FOR A DOUBLE CURL PROBLEM WITH DIVERGENCE-FREE CONSTRAINT

A DELTA-REGULARIZATION FINITE ELEMENT METHOD FOR A DOUBLE CURL PROBLEM WITH DIVERGENCE-FREE CONSTRAINT A DELTA-REGULARIZATION FINITE ELEMENT METHOD FOR A DOUBLE CURL PROBLEM WITH DIVERGENCE-FREE CONSTRAINT HUOYUAN DUAN, SHA LI, ROGER C. E. TAN, AND WEIYING ZHENG Abstract. To deal with the divergence-free

More information

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V Part I: Introduction to Finite Element Methods Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Necel Winter 4/5 The Model Problem FEM Main Ingredients Wea Forms and Wea

More information

Math 5520 Homework 2 Solutions

Math 5520 Homework 2 Solutions Math 552 Homework 2 Solutions March, 26. Consider the function fx) = 2x ) 3 if x, 3x ) 2 if < x 2. Determine for which k there holds f H k, 2). Find D α f for α k. Solution. We show that k = 2. The formulas

More information

Inner Product Spaces 6.1 Length and Dot Product in R n

Inner Product Spaces 6.1 Length and Dot Product in R n Inner Product Spaces 6.1 Length and Dot Product in R n Summer 2017 Goals We imitate the concept of length and angle between two vectors in R 2, R 3 to define the same in the n space R n. Main topics are:

More information

A DISCONTINUOUS GALERKIN METHOD FOR ELLIPTIC INTERFACE PROBLEMS WITH APPLICATION TO ELECTROPORATION

A DISCONTINUOUS GALERKIN METHOD FOR ELLIPTIC INTERFACE PROBLEMS WITH APPLICATION TO ELECTROPORATION A DISCONTINUOUS GALERIN METHOD FOR ELLIPTIC INTERFACE PROBLEMS WITH APPLICATION TO ELECTROPORATION GRÉGORY GUYOMARC H AND CHANG-OC LEE Abstract. We present a discontinuous Galerkin (DG) method to solve

More information

An a posteriori error indicator for discontinuous Galerkin discretizations of H(curl) elliptic partial differential equations

An a posteriori error indicator for discontinuous Galerkin discretizations of H(curl) elliptic partial differential equations IMA Journal of Numerical Analysis 005) Page of 7 doi: 0.093/imanum/ An a posteriori error indicator for discontinuous Galerkin discretizations of Hcurl) elliptic partial differential equations PAUL HOUSTON

More information

Iterative Methods for Linear Systems

Iterative Methods for Linear Systems Iterative Methods for Linear Systems 1. Introduction: Direct solvers versus iterative solvers In many applications we have to solve a linear system Ax = b with A R n n and b R n given. If n is large the

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 Numerical Methods for Partial Differential Equations Finite Difference Methods

More information

A Mixed Method for Axisymmetric Div-Curl Systems

A Mixed Method for Axisymmetric Div-Curl Systems Portland State University PDXScholar Mathematics and Statistics Faculty Publications and Presentations Fariborz Maseeh Department of Mathematics and Statistics 2008 A Mixed Method for Axisymmetric Div-Curl

More information

1. Let a(x) > 0, and assume that u and u h are the solutions of the Dirichlet problem:

1. Let a(x) > 0, and assume that u and u h are the solutions of the Dirichlet problem: Mathematics Chalmers & GU TMA37/MMG800: Partial Differential Equations, 011 08 4; kl 8.30-13.30. Telephone: Ida Säfström: 0703-088304 Calculators, formula notes and other subject related material are not

More information

HIGH DEGREE IMMERSED FINITE ELEMENT SPACES BY A LEAST SQUARES METHOD

HIGH DEGREE IMMERSED FINITE ELEMENT SPACES BY A LEAST SQUARES METHOD INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume 14, Number 4-5, Pages 604 626 c 2017 Institute for Scientific Computing and Information HIGH DEGREE IMMERSED FINITE ELEMENT SPACES BY A LEAST

More information

ASYMPTOTICALLY EXACT A POSTERIORI ESTIMATORS FOR THE POINTWISE GRADIENT ERROR ON EACH ELEMENT IN IRREGULAR MESHES. PART II: THE PIECEWISE LINEAR CASE

ASYMPTOTICALLY EXACT A POSTERIORI ESTIMATORS FOR THE POINTWISE GRADIENT ERROR ON EACH ELEMENT IN IRREGULAR MESHES. PART II: THE PIECEWISE LINEAR CASE MATEMATICS OF COMPUTATION Volume 73, Number 246, Pages 517 523 S 0025-5718(0301570-9 Article electronically published on June 17, 2003 ASYMPTOTICALLY EXACT A POSTERIORI ESTIMATORS FOR TE POINTWISE GRADIENT

More information

A MIXED METHOD FOR AXISYMMETRIC DIV-CURL SYSTEMS

A MIXED METHOD FOR AXISYMMETRIC DIV-CURL SYSTEMS A MIXED METHOD FOR AXISYMMETRIC DIV-CURL SYSTEMS DYLAN M. COPELAND, JAYADEEP GOPALAKRISHNAN, AND JOSEPH E. PASCIAK Abstract. We present a mixed method for a three-dimensional axisymmetric div-curl system

More information