Γ u=f on Γ, u=0 on Γ.

Size: px
Start display at page:

Download "Γ u=f on Γ, u=0 on Γ."

Transcription

1 AN ADAPTIVE FINITE ELEMENT METHOD FOR THE LAPLACE-BELTRAMI OPERATOR ON IMPLICITLY DEFINED SURFACES ALAN DEMLOW AND GERHARD DZIUK Abstract. We present an adaptive finite element method for approximating solutions to the Laplace-Beltrami equation on surfaces in R 3 which may be implicitly represented as level sets of smooth functions. Residual-type a posteriori error bounds which show that the error may be split into a residual part and a geometric part are established. In addition, implementation issues are discussed and several computational examples are given. Key words. Laplace-Beltrami operator, adaptive finite element methods, a posteriori error estimation, boundary value problems on surfaces AMS subject classification. 58J32, 65N15, 65N30 1. Introduction. In this paper we derive residual-based a posteriori error estimates for piecewise linear finite element approximations to solutions of the Laplace- Beltrami equation Γ u=f on Γ, u=0 on Γ. (1.1) Here Γ is a connected two-dimensional surface embedded in R 3 and Γ is the Laplace-Beltrami operator on Γ. Γ is required to be piecewise curvilinear in a sense which we will make precise below. We also allow Γ =, in which case the conditions Γ f dσ = u dσ = 0 are required to guarantee existence and uniqueness Γ of u. Here dσ is surface measure on Γ. A finite element method for (1.1) was introduced in [Dz88]. Let Γ h be a polyhedral approximation to Γ having triangular faces, and let S h be the continuous functions which are affine on each face of Γ h. We then let u h S h solve Γh u h Γh v h dσ h = v h f h dσ h v h S h. (1.2) Γ h Γ h Here Γh is the tangential derivative on Γ h, σ h is surface measure on Γ h, and f h is an approximation to f on Γ h. As above, we require the side conditions Γ h f h dσ h = Γ h u h dσ h = 0 if Γ h =. A key feature of our theoretical development is that Γ is represented as the 0 level set of a signed distance function d with d(x) = dist(x, Γ). Our approach requires access to the derivatives of d (the normal vector and curvature tensor), and also requires that Γ h lie in a strip about Γ on which a unique orthogonal projection a(x) onto Γ is defined. This projection is instrumental in suitably defining the discrete data f h and also in carrying out both a priori and a posteriori error analysis. Also, This material is based upon work partially supported under a National Science Foundation postdoctoral research fellowship and a grant of the Deutsche Forschungsgemeinschaft. University of Kentucky, Department of Mathematics, Patterson Office Tower 715, Lexington, Kentucky (demlow@ms.uky.edu). Abteilung für Angewandte Mathematik, Hermann-Herder-Str. 10, Freiburg, Germany (gerd@mathematik.uni-freiburg.de). 1

2 2 ALAN DEMLOW AND GERHARD DZIUK if Γ is nonempty we shall require that Γ = a( Γ h ) so that Γ is in a sense piecewise curvilinear. This is similar to requiring polygonal boundaries when performing finite element calculations on domains in R n in that it rules out variational crimes resulting from boundary approximations. In practice, Γ often is defined as a level set of a function ζ which is not a distance function. In this situation one must approximate the projection a(x) numerically, and the other necessary geometric information may then be computed in a straightforward fashion. In practical terms, the resulting finite element code requires the user to supply the data f, the level set function ζ and its first and second derivatives, and an initial mesh which lies in a sufficiently narrow strip about Γ to guarantee that the projection a is a bijection between Γ h and Γ. In the sequel we shall discuss some details of our implementation in addition to providing a posteriori error estimates. Optimal-order H 1 (Γ) and L 2 (Γ) a priori estimates for the method (1.2) were proved in [Dz88]. Roughly speaking, the finite element error may be broken into an almost-best-approximation term typical of finite element methods in R n, a geometric error term which is due to the discretization of Γ, and a data approximation term due to the approximation of f on Γ by f h on Γ h. On a mesh whose elements have diameter h, the latter two terms are of order h 2 for typical choices of f h and are thus of higher order when the error is measured in the H 1 norm. In this paper we provide a posteriori error control in the H 1 (Γ) norm via residualtype estimators. As in the a priori analysis, the error is split into three terms: a residual indicator term, a geometric error term, and a data approximation term. Computation of these error terms requires pointwise access to geometric information, in particular to the projection a and the normal vector and curvature tensor on Γ. However, the asymptotically dominant term requires no explicit geometric quantities except those which are necessary to compute the discrete data f h. A relatively simple setting is assumed here in order to concentrate on effects arising from the discretization of Γ. In particular, we do not consider problems with nonconstant coefficients, the case where a(γ h ) Γ, lower-order terms, or nonhomogeneous Dirichlet or Neumann boundary conditions. These additional complexities may be handled in much the same way as for problems on polygonal domains in R 2, so we refer for example to the works [DR98], [DW00], [BCD04], [MN05], and [AO00] where many of these issues are considered. Under suitable assumptions, our development also holds largely unchanged for surfaces of codimension 1 which are immersed in R n, n 2. In order to conclude the introduction, we briefly describe other strategies for performing adaptive finite element calculations on surfaces. One possibility is the use of a global parametrization to represent Γ and define a suitable mesh. This approach was taken in [AP05] to perform adaptive finite element calculations on the sphere. The key to this method is a global parametrization which maps a triangulated planar domain onto the sphere in such a way that the resulting curved triangles are isotropic (shape-regular). A more general approach using local parametrizations (charts) to represent 2- and 3-manifolds is described in [Ho01]. The technique we present here has several advantages when compared with the two described above. Extending the use of global parametrizations to surfaces other than the sphere is relatively difficult because a new parametrization must be found for every surface on which computations are to be performed. In addition, the analysis of the Clemént-type interpolant used to prove reliability of a posteriori estimates in [AP05] is specific to the sphere and would have to be redone for other surfaces. In

3 ADAPTIVE FEM ON SURFACES 3 contrast, implementation of our method is quite straightforward for the sphere and may be carried out in a fairly general way for a large class of surfaces. The analysis we give here also is not restricted to any particular surface. The use of local parametrizations described in [Ho01] provides a framework for computations on manifolds which is in some ways more general than that which we propose here. However, the use of overlapping local charts adds to the complexity of both the resulting finite element code and the theoretical analysis. Indeed, the issue of approximation theory when using local charts is not addressed rigorously in [Ho01]. A final advantage of our approach is that it provides rigorous theoretical background for adaptive methods in certain situations in which no parametrization is available, such as implicit computations of surfaces evolving for example by mean curvature flow (cf. [Dz91], [BMN05], [CDDRR04]). The paper is organized as follows. In 2 we give a number of preliminaries and assumptions necessary for our theoretical development. In 3 we then prove global a posteriori upper bounds and local lower bounds. In 4 our implementation is described. In 5, we demonstrate the flexibility of our approach by describing computational experiments on three different surfaces: a spherical subdomain with nonempty boundary, a torus (which is nonconvex and has a topological type different than that of the sphere), and an ellipsoid (which requires numerical approximation of the distance function). 2. Preliminaries and Assumptions The continuous surface Γ. We assume that Γ is a connected C 2 compact hypersurface which is the zero level set of a signed distance function d(x) = dist(x, Γ) defined on an open subset U 0 of R 3. If Γ = we also assume for simplicity that d < 0 on the interior of Γ and d > 0 on the exterior. ν = d is then the outward-pointing unit normal on Γ. Note that ν = 1 wherever d is defined. Let also H : R 3 R 3 3 be the Weingarten map defined by H ij (x) = ν i,xj (x) = ν j,xi (x), (2.1) that is, H(x) = D 2 d(x), and let κ i (x), i = 1, 2, and 0 be the eigenvalues of H(x). For x Γ, κ 1 and κ 2 are the principal curvatures. Next we define the projection a(x) = x d(x) ν(x). (2.2) We then let U R 3 be a strip of width δ about Γ, where δ > 0 is sufficiently small to ensure that the decomposition is unique for x U. We require that For x U, we also note the useful formula x = a(x) + d(x) ν(x) (2.3) δ < [max i=1,2 κ i L (Γ)] 1. (2.4) κ i (x) = κ i (a(x)) 1 + d(x)κ i (a(x)) (2.5) for the curvature of parallel surfaces; cf. Lemma of [GT98].

4 4 ALAN DEMLOW AND GERHARD DZIUK The condition (2.4) is sufficient to ensure that the decomposition (2.3) is locally unique (cf. [GT98], 14.6), but we require that it be globally unique. This global requirement is a simplifying assumption which restricts our presentation to embedded surfaces. Immersed surfaces (including surfaces with self-intersections) could also be considered with slight changes to our presentation. We may uniquely extend a function ψ defined on Γ to U by for x U. Let ψ l (x) = ψ(a(x)). (2.6) P = I ν ν, (2.7) where is the tensor or outer product a b = a b T (vectors here are in column form). We then define the tangential gradient Γ ψ = ψ l ( ν ψ l ) ν = P ψ l (2.8) for ψ defined on Γ and extended to U via (2.6). Note that Γ ψ depends only on the values of ψ on Γ even though its definition formally involves the extension of ψ to Γ. Note also that Γ = Γ Γ. Finally, we denote by H 1 (Γ) the functions on Γ having tangential gradient in L 2 (Γ) The discrete surface Γ h and mesh T h. Let Γ h U be a polyhedron consisting of a set T h of triangular faces, that is, Γ h = T Th T. Let also ν h denote the (piecewise constant) unit outer normal on Γ h and let N denote the set of nodes of triangles in T h. We assume that a : Γ h Γ is bijective and that ν ν h > 0 everywhere on Γ h. We note that it is often simplest to define Γ h so that N Γ, but this is not theoretically required in any way. Also denote by h T the diameter of T T h. Given z N, we define the patch ω z = interior( T z T) and let h z = max T ωz h T. Also, let E denote the set of edges of triangles in T h. Finally, ϕ z S h denotes the canonical basis function associated to z, that is, ϕ zi (z j ) = δ ij for z i, z j N. Analyses of a posteriori estimates for finite element methods on domains in R n typically assume that the underlying mesh is shape-regular, that is, all elements in T h have bounded aspect ratio. Under this assumption, constants depending on the aspect ratio of the elements of the mesh are then bounded and may be absorbed into a global constant of moderate size. This approach is reasonable because typical mesh refinement algorithms preserve shape regularity. The situation is somewhat more complicated in the current context of finite element methods on surfaces. The first issue which arises is that the mesh is perturbed after each refinement by projecting newly created nodes onto the continuous surface Γ via a. While these perturbations are asymptotically negligible, we are not aware of a proof that the refinement/perturbation procedure described here maintains shape regularity beginning from an arbitrary shape regular mesh with nodes on Γ and lying in U. A second problem is that in contrast to the situation in R n, shape regularity does not automatically imply that the number of triangles sharing a given node is bounded. However, if the number of elements in the patches of the initial coarse mesh used to begin the refinement algorithm is bounded, we may guarantee that such a bound will hold for all subsequent meshes by applying a suitable refinement algorithm. This is in particular the case for the newest-node subdivision algorithm. As we have not been able to theoretically guarantee that a family of meshes maintains shape regularity under mesh refinement, we take the following approach.

5 ADAPTIVE FEM ON SURFACES 5 We first prove a posteriori bounds which do not assume shape regularity. In these estimates, lack of shape regularity is penalized by a single factor. In our computational examples we do not include this penalty factor in our estimator, but instead monitor it to ensure that mesh quality remains acceptable. In our examples, the penalty term remains of moderate size when refining meshes which initially lie within U Lifts and extensions of functions. Given a function v h defined on Γ h, we define the lift ṽ h by v h (x) = ṽ h (a(x)) for x Γ h. We may then extend ṽ h to U by (2.6). For v h defined on Γ h and x U, we thus define v l h (x) = ṽ h(a(x)). (2.9) The overall effect of (2.9) is to extend v h defined on Γ h to U. Formally, however, this operation consists of a lift to Γ followed by extension to U. We emphasize that all extentions of functions to U referred to in this paper are constant along normals to Γ. Thus for our purposes extensions of functions defined on Γ and of functions defined on Γ h have essentially the same properties. Letting ν h denote the normal on Γ h, we define for x Γ h so that for V defined on U and x Γ h, P h (x) = I ν h (x) ν h (x), (2.10) Γh V (x) = P h V (x). (2.11) We see from (2.2) and (2.9) that for x Γ h and v h defined on Γ h, v l h(x) = [(P dh)(x)] v l h(a(x)). (2.12) Since ν ν 1, we have νh = H ν = 0 and PH = HP = H, so that for x Γ h Thus vh l (x) = [(I dh)(x)][p(x)] vl h (a(x)) = [(I dh)(x)] Γvh l (a(x)). (2.13) Γh v h (x) = Γh vh l(x) = [P h(x)][(i dh)(x)][p(x)] Γ vh l (a(x)). (2.14) Correspondingly, for ψ H 1 (Γ) (2.6) yields For x Γ h, (2.13) yields Γh ψ l (x) = [P h (x)][(i dh)(x)][p(x)] Γ ψ(a(x)). (2.15) Γ v l h(a(x)) = [(I dh)(x)] 1 v l h(x). (2.16) The invertibility of [(I dh)(x)] on U may be derived from (2.4) and (2.5). Indeed, if e 1 and e 2 are the eigenvectors of H corresponding to κ 1 (x) and κ 2 (x), then [(I dh)(x)] 1 = ν ν+(1+d(x)κ 1 (a(x)))e 1 e 1 +(1+d(x)κ 2 (a(x)))e 2 e 2. We shall need to compute Γ vh l when v h S h. In such cases we initially have access only to the tangential derivative Γh v h and not to vh l, which according to (2.16) is necessary to compute Γ vh l. Since Γ h v h (x) = [P h (x)] vh l (x), we have 0 = vl h (x) ν = Γh v h (x) ν + ( ν h ν) v h l(x) ν h. Thus vh l (x) ν h = Γ h v h (x) ν, (2.17) ν h ν

6 6 ALAN DEMLOW AND GERHARD DZIUK and for x Γ h v l h(x) = [I ν h ν ν h ν ] Γ h v h (x). (2.18) Combining (2.16) and (2.18), we thus find that for x Γ h, Γ v l h(a(x)) = [(I dh)(x)] 1 [I ν h ν ν h ν ] Γ h v h (x). (2.19) Next we state an integral equality which we shall use repeatedly. For x Γ h, let and also let µ h (x) dσ h (x) = dσ(a(x)), (2.20) A h (x) = A l h(a(x)) = 1 µ h (x) [P(x)][(I dh)(x)][p h(x)][(i dh)(x)][p(x)]. (2.21) Then from (2.14) and (2.15), we have Γh v h Γh ψ h dσ h = Γ h Γ A l h Γ v l h Γ ψ l h dσ. (2.22) Note that this equality holds without regard to the original domain of definition of v h and ψ, that is, we may for example replace ψ h and ψh l with ψl and ψ, respectively, where ψ H 1 (Γ). We also emphasize that the quantities d and H in (2.21) are always evaluated on the discrete surface Γ h, even though A l h often appears in integrals over the continuous surface Γ. Finally we give an explicit formula for the quantity µ h defined above. The proof of this formula is tedious but elementary, and we sketch it in Appendix A. Proposition 2.1. Assume that x Γ h. Then µ h (x) = (1 d(x)κ 1 (x))(1 d(x)κ 2 (x)) ν ν h. (2.23) 2.4. Interpolation and Poincaré inequality. In this section we define an interpolant and prove error bounds for it. Given ψ L 1 (Γ) and z N, we let ψz l 1 = ϕ z ψ l dσ h (2.24) ω z ϕ z dσ h ω z and define I h ψ l = ψzϕ l z. (2.25) z N A similar interpolant is used for example in [FV06] to prove a posteriori bounds on a domain in R 2. Noting that {ϕ z } z N is a partition of unity, we then have the following relationship: (ψ l I h ψ l ) dσ h = (ψ l ψz)ϕ l z dσ h = 0. (2.26) Γ h z N ω z

7 ADAPTIVE FEM ON SURFACES 7 Lemma 2.2. (Poincaré inequality) Let ψ H 1 (Γ). Let m z be the number of elements sharing the node z, and let ω z be the lift of the patch ω z onto Γ. Then for each z N, ψ l ψz l h L2(ω z) C max T mz max T A h 1 2 T ω z T ω z T l2,l (ω z) Γψ L2( ω z). (2.27) Let also z e E. Then ψ l ψz l L 2(e) C h T e m z max A h 1 2 T ω z T l2,l (ω z) Γψ L2( ω z). (2.28) Here A h l2,l (ω z) = A h l2 l 2 where L (ω z) l 2 l 2 is the standard matrix 2-norm, and C does not depend on any essential quantities. Remark 2.3. The terms in (2.27) and (2.28) may be classified as follows. In shape-regular meshes the quantities max T ωz T and e may be reduced to hz and h 1/2 z, respectively, where h z is the maximum element diameter in ω z. The factor m z accounts for the number of elements sharing the vertex z if this number is not known to be bounded, and the factor max T ωz h T / T accounts for the aspect ratio of T. If T h is shape regular and m z is bounded, we thus have ψ l ψ l z L 2(ω z) Ch z A h 1 2 l2,l (ω z) Γ h ψ l L2(ω z), (2.29) ψ l ψ l z L2(e) Ch 1/2 z A h 1 2 l2,l (ω z) Γψ L2( ω z), (2.30) where C does not depend on essential quantities. Proof. We first show that I h is locally L 2 -stable independent of mesh properties. Note first that ψz l L2(ω z) = ω z 1/2 ψz l ω z 1/2 ϕ z L2(ω z) ψ l L2(ω ϕ z z). (2.31) L1(ω z) If z is an interior node, we let ˆω z be a regular m z -gon with vertices lying on the unit circle. If z is a boundary node, then we let ˆω z be a half of a regular 2m z -gon with vertices lying on the unit circle. In either case the reference domain ˆω z is convex and may be broken into m z congruent triangles with the origin being a vertex of each. There is a natural piecewise-affine transformation F z : ˆω z ω z. We denote by ˆT the inverse image of T ω z and by û the inverse image of u H 1 (Γ h ) under this transformation. For p = 1 or p = 2 and any ˆT ˆω z, ϕ z p L = p(ω z) ϕ p z dσ h = T T ω T z T ω z ˆT An elementary calculation yields ˆT ˆϕz L 2 ( ˆT) ˆϕ z L1 ( ˆT) (2.31) and (2.32) yields ˆT ˆϕ p z dˆx = ω ˆT z ˆϕp z dˆx ˆT. (2.32) =, which when combined with 3 2 Thus for any K R, ψ l z L2(ω z) 3 2 ψl L2(ω z). (2.33) ψ l ψ l z L 2(ω z) ( ) ψl K L2(ω z) (2.34)

8 8 ALAN DEMLOW AND GERHARD DZIUK that Choosing K = 1 ˆω z ˆω ˆψl z dˆx and noting that ˆψ l = Γh ψ l F z, we next find ψ l K 2 L = T 2(ω z) T ω z ˆT ˆT ( ˆψ l K) 2 dˆx = 1 ˆT max T ω z T ˆω z ( ˆψ l K) 2 dˆx C P (ˆω z ) 2 1 ˆT max T ω z T ˆω z ˆψ l 2 dˆx = C P (ˆω z ) 2 1 ˆT max T ω z T ˆT T ω z T T Γ h ψ l F z 2 dσ h C P (ˆω z ) 2 max T ωz T max T ωz F z T 2 l 2 l 2 T Γh ψ l 2 L 2(ω z). Here C P is the Poincaré constant for ˆω z. It is not hard to compute that (2.35) F z T l2 l 2 Cm z h T, (2.36) where C does not depend on any essential quantities. Combining (2.34), (2.35), and (2.36) and finally applying (2.22) yields (2.27). The proof of (2.28) is accomplished by employing a trace inequality and slightly modifying the preceding proof. Assume that e T ω z. Let Ť be the unit simplex in R 2 (note that this is not the same as the reference element employed above), with ê denoting the transformation of e to Ť. Letting ˆF T denote the affine transformation of Ť to T, we note that ˆF T l2 l 2 h T. Employing a trace inequality on Ť then yields ψ l ψz l L2(e) e ˆψ l ψz l L2(ê) C e ( ˆψ l ψz l L + ˆψ l 2(Ť) L2(Ť)) C e T ( ψl ψz l L2(T) + h T Γh ψ l L2(T)). (2.37) e / T ht Γh ψ l L2(T) is clearly bounded by the right hand side of (2.28), so we must only consider the first term in the last line above. Letting ˆT, ˆω z, and K be as defined as before, we first procede as in (2.35) to find that e e T ψl K L2(T) ˆT ˆψ l K L2( ˆT) e ˆT ˆψ l K L2(ˆω z) C h e m z max T T ωz Γh ψ l L2(ω T z). Proceeding as in (2.31) through (2.34), we next find that e T (ψl K) z L2(T) e (ψ l K) z 3 2 e ω z ψl K L2(ω z). (2.38) (2.39) Combining (2.39) and (2.35) yields e T (ψl K) z L2(T) C e max T ωz T ω z m z maxt ω z h T T Γh ψ l L2(ω z) C e m z max T ωz h T Γh ψ l L2(ω T z). (2.40) Since ψ l ψ l z L 2(T) ψ l K L2(T) + (ψ l K) z L2(T), combining (2.37), (2.38), and (2.40) with (2.22) completes the proof of (2.28).

9 ADAPTIVE FEM ON SURFACES 9 3. The estimator. In this section we develop a computable and reliable estimator for Γ (u u l h ) L 2(Γ) Residual equation. We first derive a residual equation. Let ψ H 1 0 (Γ), where H 1 0(Γ) is the set of functions in H 1 (Γ) having vanishing trace if Γ and having vanishing mean value if Γ =. Following [Dz88] and applying (2.22), we find that for ψ H 1 (Γ) and ψ h S h, Γ Γ(u u l h ) Γψ dσ = Γ h f l µ h ψ l dσ h Γ [P Al h ] Γu l h Γψ dσ Γ h Γh u h Γh ψ l dσ h (3.1) and Γ (u u l h) Γ ψh l dσ = Γ h f l µ h ψ h dσ h Γ [P Al h ] Γu l h Γψh l dσ Γ Γh u h Γh ψ h dσ h Γ h = (f l µ h f h )ψ h dσ h [P A l h] Γ u l h Γ ψh l dσ. Γ h Γ (3.2) Combining (3.1) and (3.2), we find that Γ Γ (u u l h ) Γψ dσ = Γ Γ(u u l h ) Γψ dσ Γ Γ(u u l h ) Γψh l dσ + Γ (u u l h) Γ ψh l dσ Γ = f l µ h (ψ l ψ h ) dσ h Γh u h Γh (ψ l ψ h ) dσ h Γ h Γ h [P A l h] Γ u l h Γ ψ dσ + (f l µ h f h )ψ h dσ h. Γ h Γ (3.3) Next we note that Γh u h Γh (ψ l ψ h ) dσ h Γ h = Γh u h (ψ l ψ h ) dσ h T T T h = Γh u h (ψ l ψ h ) dσ h 1 Γ h 2 T T Γh u h n(ψ l ψ h ) ds Γh u h (ψ l ψ h ) ds. T T (3.4) where Γh u h is a piecewise polynomial and n is the conormal vector to the triangle T (that is, n ν h = 0). In the current situation Γh u h is identically 0, but we include it to make clear how the corresponding term would appear in other situations. Also, let e be an edge shared by elements T 1 and T 2 which have normals n 1 and n 2, respectively. Then Γh u h = Γh u h T1 n 1 Γh u h T2 n 2 is the jump in the normal derivative across e. If e Γ h we set Γh u h e = 0. Note that n 1 lies in the plane of T 1 and n 2 lies in the plane of T 2, so in contrast to the situation which arises on domains in

10 10 ALAN DEMLOW AND GERHARD DZIUK R n we generally have n 1 n 2 Finally, we insert (3.4) into (3.3) to find Γ (u u l h ) Γψ dσ = Γ h (f l µ h + Γh u h )(ψ l ψ h ) dσ h Γ 1 Γh u h (ψ l ψ h ) ds [P A l h 2 ] Γu l h Γψ dσ T T T Γ + (f l µ h f h )ψ h dσ h Γ h I + II + III + IV. (3.5) 3.2. A posteriori upper bound (reliability). We begin by bounding term I of (3.5). Let ψ h = I h ψ l h, and let s z = m z max T T ωz. Also let R = f l µ h + Γh u h, T and let {R z } z N be constants. Recalling that {ϕ z } z N is a partition of unity, recalling (2.25) and (2.26), and applying Lemma 2.2, we then have I = R(ψ l ψz l )ϕ z dσ h = (R R z )(ψ l ψz l )ϕ z dσ h (3.6) z N ω z z N ω z C z N max T ω z T sz A h 1 2 l2,l (ω z) ϕ z(r R z ) L2(ω z)h z Γ ψ L2( ω z). Next we turn to bounding the term II. Applying Lemma 2.2, we find II = 1 2 z N e z e ϕ z Γh u h (ψ l ψz l) ds C e sz A h 1 2 ϕ l2,l (ω z) z Γh u h L2(e) Γ ψ (3.7) L2( ω z). z N Let e z η z = s z (max T ωz T ϕz (R R z ) L2(ω z) + e z e ϕz Γh u h L2(e)). (3.8) Combining (3.6) and (3.7) and noting that each element T has only three nodes, we thus find that I + II C z N A h 1 2 l2,l (ω z) η z Γ ψ L2( ω z) C( z N A h l2,l (ω z)η 2 z) 1/2 ( z N Γ ψ 2 L 2( ω z) )1 2 (3.9) C( z N A h l2,l (ω z)η 2 z) 1/2 Γ ψ L2(Γ), where C does not depend on T h or any other essential quantities. In order to bound the term III, we use (2.19) to compute III = ϕ l z[p A l h] Γ u l h Γ ψ dσ z N ω z ϕ l z [P Al h ] Γu l h L 2( ω z) ϕ l z Γψ L2( ω z) z N = µ h ϕz [P A h ][I dh] 1 [I ν h ν ν h ν ] Γ h u h L2(ω z) z N ϕ l z Γ ψ L2( ω z). (3.10)

11 Defining ADAPTIVE FEM ON SURFACES 11 B h = µ h [P A h ][I dh] 1 [I ν h ν ν h ν ] (3.11) and recalling that z N ϕ z = z N ϕl z 1, we finally compute III ( z N ϕ z B h Γh u h 2 L 2(ω z) )1/2 ( z N ϕ l z Γ ψ 2 L 2( ω z) )1/2 = B h Γh u h L2(Γ h ) Γ ψ L2(Γ). (3.12) Finally we bound the term IV. First we note that for z N and with ψz l defined as in (2.24), ϕ z ψz l 1 L 2(Ω z) = ϕ z dσ h ϕ z ψz ω z ω l z ϕ z dσ dσ h h ω z (3.13) ϕ z ψ l L2(ω z). Since ψ H0 1 (Γ) has either vanishing trace on Ω or vanishing mean value over Ω, we may apply (3.13) and a Poincaré inequality to compute IV = (f l µ h f h )ψ h dσ h Γ h = (f l µ h f h )ϕ z ψz l dσ h z N ω z z N ϕ z (f l µ h f h ) L2(ω z) ϕ z ψ l z L 2(ω z) ϕ z (f l µ h f h ) L2(ω z) ϕ z ψ l L2(ω z) z N 1 L (ω µh z) ϕ z (f l µ h f h ) L2(Γ h ) ϕ l z ψ L 2( ω z) z N (3.14) ( 1 L (ω µ z) ϕ z (f l µ h f h ) 2 L 2(Γ h ) )1/2 ψ L2(Γ) h z N C P (Γ)( 1 L (ω µ z) ϕ z (f l µ h f h ) 2 L 2(Γ h ) )1/2 Γ ψ L2(Γ). h z N Making the substitution ψ = u u l h if Γ or ψ = u ul h 1 Γ Γ (u ul h ) dσ if Γ = while combining (3.3), (3.12), and (3.14) yields Γ (u u l h ) 2 L 2(Γ) [C( z N A h l2,l (ω z)η 2 z )1/2 + B h Γh u h L2(Γ h ) +C P (Γ)( z N 1 µ h L (ω z) ϕ z (f l µ h f h ) 2 L 2(Γ h ) )1/2 ] (3.15) where Γ (u u l h) L2(Γ). Dividing (3.15) through by Γ (u u l h ) L 2(Γ) then yields the following theorem. Theorem 3.1. Under the assumptions in 2, Γ (u u l h ) L 2(Γ) R + G + D, (3.16) R = C( z N A h l2,l (ω z)η 2 z) 1/2, (3.17)

12 12 ALAN DEMLOW AND GERHARD DZIUK G = B h Γh u h L2(Γ h ), (3.18) and D = C P (Γ)( z N 1 µ h L (ω z) ϕ z (f l µ h f h ) 2 L 2(Γ h ) )1/2. (3.19) Here η z = s z (max T ωz T ϕz (R R z ) L2(ω z) + e z e ϕz Γh u h L2(e)) as in (3.8), the constants R z in η z may be freely chosen, and C does not depend on T h or Γ. We make a few brief remarks concerning Proposition 3.1, beginning with the residual term R. First we note that if the nodes of Γ h lie on Γ, then [(P A h )(x)] l2 l 2 Ch 2 T for x T (cf. [Dz88]). Thus up to a higher-order term, R is bounded by C( z N η2 z) 1/2. Next we consider the geometric error term G. Note first that unlike the residual term R, it contains no unknown constants. Secondly, G is heuristically of higher order since B h l2 l 2 C P A h l2 l 2 Ch 2 T. The data approximation term D is 0 if we let f h = µ h f l and assume exact quadrature, both of which we shall do in our numerical tests. In [Dz88] the definition f h (x) = f l (x) 1 Γ h Γ h f l dσ h is made. This choice has the advantage of not requiring the computation of the ratio µ h of the continuous to the discrete measure and still leads to optimal-order H 1 and L 2 estimates. However, computation of R and G requires access to µ h in any case, so we shall use the definition f h = µ h f l and thereby exclude D. A final note concerning D is that it includes the global Poincaré constant C P (Γ). In contrast to the terms R and G, D is thus not entirely built up of quantities which are locally determined. Finally we note that the dominant term in (3.16) does not depend explicitly on geometric information about Γ. Since A h P l2,l (ω z) C( ω z )h 2 z, we may compute G ( z N C( ω2 z )h4 z ϕ z Γh u h 2 L 2(ω z) )1/2. Also, R C( z N η2 z + C(Γ)h2 z η2 z )1/2. Finally, as shown in [Dz88], D is of higher order even if the choice f h (x) = f l (x) 1 Γ h Γ h f l dσ h is made. Thus the dominant part of the a posteriori upper bound is C( z N η2 T )1/2, exactly as for problems in planar domains. The estimator given in Theorem 3.1 could in principle be implemented, but it is possible to define a more convenient estimator for practical use. Recalling the comments of 2.2, we may simplify it by assuming shape-regularity. In addition, residual estimators are typically calculated elementwise instead of patchwise, so we define an alternate estimator which allows mostly elementwise calculations (the only exception is the term involving A h, which must be patch-based). In our computations we shall apply the estimator naturally derived from the following proposition. Corollary 3.2. Assume that f h = µ h f l, that T h is shape regular, and that m z is bounded. Then Γ (u u l h) L2(Γ) 2( C A h l2,l (ω T )ηt 2 + B h Γh u h 2 L 2(T) )1/2 Θ. T T h (3.20) Here ω T = z T ω z, η T = h T R L2(T) + h 1/2 T Γ h u h L2( T), and C depends on max z N m z and the minimum angle over all elements of T h. The proof of Corollary 3.2 follows by setting R z = 0 in (3.8) and noting that under the assumptions that T h is shape regular and m z is bounded, h T is equivalent to h z for all vertices z of T and to e for all e T A posteriori lower bound (efficiency). In this section we prove a local a posteriori lower bound which is a counterpart to the upper bound in Corollary

13 ADAPTIVE FEM ON SURFACES Such lower bounds verify (up to higher-order terms) that the stated a posteriori estimate does not overestimate the actual error and also are an essential ingredient in proving the convergence of adaptive methods; cf. [MNS02]. Proposition 3.3. Assume that f h = µ h f l, that T h is shape regular, and that m z is bounded. Then for T T h, η T C A h 1/2 l 2,L (ω T ) ( Γ(u u l h ) L 2( ω T ) + B h Γh u h L2(ω T )) +Ch T R R T L2(ω T ). (3.21) Here C depends on max z N:z T m z and the minimum angle of the elements in ω T, and R T is an arbitrary piecewise linear function. Proof. We shall follow the well-known proof of Verfürth (cf. [Ver89]). First let z N and T ω z. Letting z i, 1 i 3, be the nodes of T, we define the bubble function φ T = Π 3 i=1 ϕ z i. In addition, let R T be an arbitrary piecewise linear approximation to R on T. Let also T denote the natural lift of T to Γ. Then using (3.5) with ψ = RT l φl T and ψ h = 0 and noting that φ T = 0 on T, we have R R T φ T dσ h = T Γ (u u l h ) Γ(RT l φl T ) dσ T + [I A l h ] Γu l h Γ(RT l φl T ) dσ T ( Γ (u u l h) L2( T) + [I Al h] Γ u l h L2( T) ) Γ(RTφ l l (3.22) T) L2( T) ( Γ (u u l h) L2( T) + B h Γh u h L2(T)) A h 1/2 L (T) Γ h (R T φ T ) L2(T). Since R T φ T is a polynomial, we may apply an inverse inequality to find Γh (R T φ T ) L2(T) Ch 1 T R Tφ T L2(T) Ch 1 T R T L2(T). (3.23) where C depends only on the shape regularity of T. Thus R R T φ T dσ h T Ch 1 T A h 1/2 L (T) ( Γ(u u l h ) L 2( T) + B h Γh u h L2(T)) R T L2(T). (3.24) Applying Theorem 2.2 of [AO00], we next note that R T 2 L 2(T) φ T R T 2 L 2(T) ( φ T (R R T ) L2(T) + ( RR T φ T dσ h ) 1/2 ) R T L2(T). T (3.25) Combining the previous inequalities, we thus find R T 2 L 2(T) C[ R R T L2(T) + h 1 T A h 1/2 L (T) ( Γ(u u l h ) L 2( T) + B h Γh u h L2(T))] R T L2(T). (3.26) Thus h T R L2(T) C[ A h 1/2 L (T) ( Γ(u u l h ) L 2( T) + B h Γh u h L2(T)) +h T R R T L2(T)]. (3.27)

14 14 ALAN DEMLOW AND GERHARD DZIUK Next we bound the edge residual Γh u h L2( T). Let e be an edge which is shared by elements T 1 = T and T 2 and whose closure contains the nodes z 1 and z 2. Let λ i,j, i, j = 1, 2, be the barycentric coordinate on triangle i corresponding to the vertex z j, and define φ e Ti = λ i,1 λ i,2. Thus φ e H 1 0 (T 1 T 2 ), and φ e > 0 on e. Then Γh u h L2(e) C φ e Γh u h L2(e). (3.28) Noting that Γh u h e is a constant, we employ (3.5) with ψ = ( Γh u h e φ l e) to find e Γh u h 2 φ e ds = T1 T 2 Γ (u u l h ) Γ( Γh u h e φ l e) dσ T 1 T 2 R Γh u h e φ e dσ h + T1 T 2 [I A l h ] Γu l h Γ( Γh u h e φ e ) dσ Γh u h e ( Γ (u u l h ) L 2( T 1 T A 2) h 1/2 L (T 1 T 2) Γ h φ e L2(T 1 T 2) (3.29) + R L2(T 1 T 2) φ e L2(T 1 T 2) + B h Γh u h L2(T 1 T 2) A h 1/2 L (T 1 T 2) Γ h φ e L2(T 1 T 2)). A simple scaling argument yields φ e L2(T 1 T 2) Ch T and Γh φ e L2(T 1 T 2) C, so that Γh u h 2 φ e ds Ch 1/2 T Γh u h L2(e) e [ A h 1/2 L (T 1 T 2) Γ(u u l h) L2( T 1 T 2) +h T R L2(T 1 T 2) + A h 1/2 L (T 1 T 2) B h Γh u h L2(T 1 T 2)]. Combining the previous three inequalities, we find that (3.30) h 1/2 T Γh u h L2(e) C( A h 1/2 L (T 1 T 2) Γ(u u l h ) L 2( T 1 T 2) +h T R L2(T 1 T 2) + A h 1/2 L (T 1 T 2) B h Γh u h L2(T 1 T 2)). (3.31) Summing (3.31) over the three edges of T and combining (3.31) with (3.27) completes the proof of (3.21). 4. Implementation details. In this section we provide some details concerning implementation Computation of geometric quantities. We assume that Γ = {x R 3 : ζ(x) = 0}, where ζ is sufficiently smooth with nonzero gradient in a large enough neighborhood of Γ. In addition, we assume that ζ, its gradient, and its Hessian matrix are available, and that for x U we can approximate a(x) with sufficient accuracy. In the next subsection we describe a simple approach for approximating a(x). First we note that if x Γ, ν(x) = ζ ζ. Thus for x U, In addition, we have for x Γ ν(x) = ζ(a(x)) ζ(a(x)). (4.1) H(x) = Γ ν(x) = P ζ(x) ζ(x). (4.2) For the sake of concreteness, we note that ζ(x) ζ(x) is not necessarily symmetric,and that [ ζ ζ ] ij = ζ xj x i ζ. The eigenvalues κ 1 and κ 2 of H in the directions orthogonal

15 ADAPTIVE FEM ON SURFACES 15 to ν may then be approximated numerically. We also recall the relationship κ i (x) = κ i(a(x)) 1+d(x)κ i(a(x)) from (2.5). Finally, we emphasize that d is the signed distance function, that is, d(x) = sign(ζ(x)) a(x) x for x U \ Γ. The above information is sufficient to implement the adaptive method described above. In particular, for x Γ h we use (2.23) to define the discrete data f h (x) = µ h (x)f(a(x)) = (1 d(x)κ 1 (x))(1 d(x)κ 2 (x)) ν(x) ν h (x)f(a(x)). (4.3) Here ν(x) is computed via (4.1), κ 1 and κ 2 are computed via (2.5), and ν h must be computed from mesh information. Next we note that and A h (x) l2 l 2 max(1 d(x)κ 1 (x), 1 d(x)κ 2 (x)) ν(x) ν h (x) min(1 d(x)κ 1 (x), 1 d(x)κ 2 (x)) A h(x) (4.4) B h (x) l2 l 2 1 µ h (x) [ d(x)(κ 1(x) κ 2 (x)) + 1 ν(x) ν h (x) (1 + 4 max(1 d(x)κ 1 (x), 1 d(x)κ 2 (x)))] B h (x). (4.5) The expressions on the right hand sides of (4.4) and (4.5) may be computed using (4.1) and (2.5) as before. Since P A h and B h are of higher order, using the above approximations for the norms of A h and B h should lead to at most a slight overestimation of the overall error while yielding nontrivial computational savings Computation of d and a. The efficient computation of the projection a and distance function d are central to implementing the finite element method and a posteriori estimators described here. In a very few cases, d is available explicitly (for example, d(x) = x r for a sphere of radius r). Even for relatively simple surfaces such as ellipsoids, however, an explicit expression for d is not available, and a and d must be approximated. Since d is assumed to be smooth and we only need to be concerned about starting points sufficiently close to Γ, standard methods of nonlinear optimization are in principle applicable. We have tested two different algorithms for computing a, one being Newton s method and the other being an ad hoc first-order method. Before describing the methods we note a relationship which we shall use in our algorithms. For x U, ζ(x) = d(x) 0 ζ(a(x) + t ν(x)) ν(x) dt = d ζ(x) + O(d 2 ). Thus d(x) ζ(x) ζ(x). (4.6) Next we describe our implementation of Newton s method. Assume that x 0 U, and that we wish to compute a(x 0 ). In order to employ Newton s method, we seek a stationary point of the function F(x, λ) = x x 0 + λζ(x). Note that F(x, λ) = (2(x x 0 ) + λ ζ(x), ζ(x)). Thus F(x, λ) = 0 implies that x Γ and (x x 0 ) is parallel to ζ(x), that is, x = a(x 0 ). In order to choose a starting point, we note that 2(x x 0 )+λ ζ(x) = 0 implies that λ = 2d(x 0 )/ ζ(x). Using (4.6), we thus choose the starting value (x 0, λ 0 ) = (x 0, 2φ(x 0 )/ φ(x 0 ) 2 ) for Newton s method. Given a tolerance tol, we iterate Newton s method until ( ζ(x) 2 ζ(x) 2 + ζ(x) ζ(x) x x 0 ) 2 1/2 x x 0 < tol. (4.7)

16 16 ALAN DEMLOW AND GERHARD DZIUK Fulfillment of this stopping criteria guarantees that the returned value x a(x 0 ) lies in the correct direction from x 0 to within tol and that because of (4.6), d(x) < tol up to higher-order terms. The first-order algorithm which we employed may be described as follows. Since a(x) = x d(x) ν(x), we may use (4.6) and ν(x) ζ(x) ζ(x) to approximate a by a(x) x ζ(x) ζ(x) ζ(x). Iterating this relationship leads to an algorithm which converges 2 to some point on Γ, but not generally to a(x). We thus correct the direction x x 0 at each step, yielding the following algorithm. 1. Stipulate tol and x 0, and initialize x = x While (4.7) is not satisfied, iterate the following steps: (a) Calculate x = x ζ(x) ζ(x) ζ(x) and dist = sign(ζ(x 2 0 )) x x 0. (b) Set x = x 0 dist ζ( x) ζ( x). In practice, the second of the two algorithms was more efficient than Newton s method. While Newton s method converged in less steps as one would expect, each step is relatively expensive. We also note that we have not rigorously analyzed the error in either of these methods which results from using the stopping criterion (4.7). A more rigorous analysis of robust algorithms for approximating a would thus be desirable. 5. Computational examples. In this section we describe several computational examples. All computations were performed using the finite element toolbox ALBERTA ([SS05]), and graphics were processed using the software GMV [Or05]. Also, the constant C appearing in the estimator Θ in (3.20) was taken to 0.25 in all calculations Example 1: Computation on a spherical subdomain. In our first test we consider a problem which was used as an example in the paper [AP05]. This problem demonstrates the ease with which our method handles problems in which the distance function is explicitly available and also provides a convenient place to consider surfaces with boundary. Let S 2 be the unit sphere with angular spherical coordinates (φ, θ), where φ (0 φ < 2π) is the azimuthal angle in the xy-plane and θ = cos 1 z (0 θ π) is the polar angle from the z-axis. Following [AP05], we let Γ consist of points in S 2 such that 0 φ 5π 3, and let u(φ, θ) = (sinθ)λ sin λφ for λ =.6. Then u satisfies Γ u = f in Γ and u = 0 on Γ with f = λ(λ + 1)(sinθ) λ sin λφ. Note that u is singular at the poles, so we may expect an adaptive algorithm to refine more heavily there. Computation of the geometric quantities necessary to implement our method is quite straightforward. We employ the distance function d(x) = x 1 for the sphere (note that we do not actually require access to the distance function for Γ here). In addition, we may easily compute that ν(x) = x x, a(x) = x x, and H ij(x) = δij x xixj x. 3 The eigenvalues of H(x) are the principle curvatures of the sphere of radius x, that is, κ 1 = κ 2 = 1 x. Computation of µ h, A h and B h is similarly straightforward. In Figure 5.1, the initial mesh of six elements is displayed along with an adaptively refined mesh colored with the solution u h. A blowup showing refinement near the positive z-pole is displayed in Figure 5.2. Finally, a graph displaying the error, the residual estimator Θ defined in (3.20), and various geometric quantities is given in h Figure 5.3. First note that the quantity max T T Th appears to reach a maximum T value of about 3. Thus our assumption in Corollary 3.2 that the mesh is shape regular

17 ADAPTIVE FEM ON SURFACES 17 Fig Experiment 1: The initial mesh with 6 nodes (left) and adaptively refined meshes with 151 (center) and 5559 (right) DOF displaying u h. Fig Experiment 1: View of the refined mesh along the z-axis, magnified 80X, with contour lines of u. is justified for this example. Also, the error Γ (u u l h ) L 2(Ω) and residual estimator Θ converge with optimal order and appear to have a constant ratio as the mesh is refined. Finally, the quantities B h Γh u h L2(Γ h ) and 1 A h L (Γ h ) are plotted and show second-order convergence, confirming experimentally our theoretical observation that these geometric contributions to the error are of higher order. It is worth noting here that the quantity A h appears in the estimator as a multiplicative factor. Since it converges to 1, it would thus be reasonable and computationally more efficient to omit it entirely once A h L (Γ h ) is observed to reach a given tolerance.

18 18 ALAN DEMLOW AND GERHARD DZIUK Log max T Th h T / p T Θ Γ (u u l h ) L 2 (Γ) Slope =.5 B h Γh u h L2 (Γ h ) 1 A h L (Γ h ) Slope = Log(DOF) Fig Experiment 1: Error, estimator, and various geometric quantities Example 2: Computation on a torus. In our second test we performed a computation on a torus. d(x) = (r 0 x 2 + y 2 ) 2 + z 2 r 1 is the signed distance function for a torus whose axis of revolution is the z-axis, whose radius of revolution is r 0, and which has thickness 2r 1. The other necessary geometric quantities may be computed from this formula. We took r 0 = 1 and r 0 = As a test solution we took the function 1 u(x, y, z) = e 1.85 x 2 siny, (5.1) which has exponential peaks on the outer portions of the torus which lie near the x-axis. Fig Experiment 2: The initial mesh displaying A h (left) and refined mesh with 1248 DOF displaying u h (right). In Figure 5.4 we display A h on the the initial 24-node mesh; note that here A h is about 5 on the outer edge of the torus, so it enters into the calculation in a significant way. Also displayed in Figure 5.4 is a refined mesh having 1248 nodes and displaying

19 ADAPTIVE FEM ON SURFACES 19 the discrete solution u h. In Figure 5.5 we display the local H 1 error contributions along with the three components A h, η T, and B h Γh u h of the estimator Θ. The local residual indicator η T reflects reasonably well the local error distribution, while the contributions from A h and B h Γh u h are relatively insignificant. Also, the maximum ratio h T / T observed during this calculation was This relatively large number reflects the fact that the triangles in the initial mesh displayed in Figure 5.4 already have relatively high aspect ratios. Fig Experiment 2: The local residual η T (top left), H 1 error (top right), B h Γh u h (bottom left), and A h (bottom right) Example 3: Computation on an ellipsoid. In our third computational example we let Γ be an ellipsoid satisfying the level set equation x 2 + y 2 + z2 = 1. (5.2) 400 As a test solution we took u(x, y, z) = sin y so that u and its derivatives were of moderate size. In Figure 5.6 we display the local residual contribution η T and the local geometric error B h Γh u h on an adaptively refined mesh having nodes. Note that the maximum values of η T and B h Γh u h are approximately equal. Thus the geometric error plays a role in the marking of some elements even on a refined mesh. As in Figure 5.3, however, the overall geometric error B h Γh L2(Γ h ) declines approximately as DOF 1, while the residual error ( T T h η 2 T )1/2 declines as DOF 1/2 (we do not display a chart for the current situation as it is entirely analogous to Figure 5.3). Finally, the maximum ratio h T / T observed in this adaptive calculation (up degrees of freedom) was 3.41, so that mesh quality remained reasonable. Appendix. Proof of Proposition 2.1. Proposition 2.1 is potentially of interest in other situations (e.g., when Γ h is a higher-order polynomial approximation to Γ), so we begin by stating a more general version. Proposition A.1. Let ˆT be the unit simplex in R 2, and suppose that F : ˆT U is a C 1 mapping whose gradient has two nonzero singular values at each point in ˆT.

20 20 ALAN DEMLOW AND GERHARD DZIUK Fig Experiment 3: Mesh with nodes displaying the relative sizes of B h Γh u h (left) and the local residual η T (right). The view is along the z-axis. Suppose x T := F( ˆT), let ν h be the normal to T at x, and let dσ h be surface measure on T. Assume also that ν ν h > 0. Letting dσ h (x)µ h (x) = dσ(x), we then have µ h (x) = ν ν h (1 d(x)κ 1 (x))(1 d(x)κ 2 (x)). (A.1) Proof. We fix a point ˆx ˆT and let x = F(ˆx) and R 3 2 A = F(ˆx). Let { e 1, e 2 }, { u 1, u 2 }, and { v 1, v 2 } be orthonormal bases for R 2 and the tangent spaces to Γ h and Γ at x and a(x), respectively. We assume also that { v 1, v 2, ν} are the eigenvectors of (I dh)(x) corresponding to the eigenvalues λ 1 = 1 d(x)κ 1 (x), λ 2 = 1 d(x)κ 2 (x), and λ 3 = 1. Letting denote the cross product, we have dσ h = A e 1 A e 2 dˆx and dσ = ([I dh][p][a] e 1 ) ([I dh][p][a] e 2 ) dˆx. Next we recall the formula (B x 1 ) (B x 2 ) = B adj ( x 1 x 2 ), where B is symmetric and nonsingular and B adj = (detb)b 1. Noting that (I dh) adj has eigenvectors { v 1, v 2, ν} with eigenvalues {λ 2 λ 3, λ 1 λ 3, λ 1 λ 2 }, we calculate ([I dh][p][a] e 1 ) ([I dh][p][a] e 2 ) = λ 2 λ 3 [([P][A] e 1 [P][A] e 2 ) v 1 ] v 1 + λ 1 λ 3 [([P][A] e 1 [P][A] e 2 ) v 2 ] v 2 + λ 1 λ 2 [([P][A] e 1 [P][A] e 2 ) ν] ν (A.2) But ([P][A] e 1 [P][A] e 2 ) v i, i = 1, 2, ([P][A] e 1 [P][A] e 2 ) ν = (A e 1 A e 2 ) ν, and A e 1 A e 2 ν h. Thus dσ = ([I dh][p][a] e 1 ) ([I dh][p][a] e 2 ) dˆx = λ 1 λ 2 [(A e 1 A e 2 ) ν] ν dˆx = λ 1 λ 2 A e 1 A e 2 ν h ν dˆx. (A.3) Recalling that dσ h = A e 1 A e 2 dˆx completes the proof. REFERENCES [AO00] M. Ainsworth and J. T. Oden, A posteriori error estimation in finite element analysis, Pure and Applied Mathematics (New York), Wiley-Interscience [John Wiley & Sons], New York, 2000.

21 ADAPTIVE FEM ON SURFACES 21 [AP05] T. Apel and C. Pester, Clement-type interpolation on spherical domains interpolation error estimates and application to a posteriori error estimation, IMA J. Numer. Anal., 25 (2005), pp [BMN05] E. Bänsch, P. Morin, and R. H. Nochetto, A finite element method for surface diffusion: the parametric case, J. Comput. Phys., 203 (2005), pp [BCD04] S. Bartels, C. Carstensen, and G. Dolzmann, Inhomogeneous Dirichlet conditions in a priori and a posteriori finite element error analysis, Numer. Math., 99 (2004), pp [CDDRR04] U. Clarenz, U. Diewald, G. Dziuk, M. Rumpf, and R. Rusu, A finite element method for surface restoration with smooth boundary conditions, Comput. Aided Geom. Design, 21 (2004), pp [DR98] W. Dörfler and M. Rumpf, An adaptive strategy for elliptic problems including a posteriori controlled boundary approximation, Math. Comp., 67 (1998), pp [DW00] W. Dörfler and O. Wilderotter, An adaptive finite element method for a linear elliptic equation with variable coefficients, ZAMM Z. Angew. Math. Mech., 80 (2000), pp [Dz88] G. Dziuk, Finite elements for the Beltrami operator on arbitrary surfaces, in Partial differential equations and calculus of variations, vol of Lecture Notes in Math., Springer, Berlin, 1988, pp [Dz91] G. Dziuk, An algorithm for evolutionary surfaces, Numer. Math., 58 (1991), pp [FV06] F. Fierro and A. Veeser, A posteriori error estimates, gradient recovery by averaging, and superconvergence, Numer. Math., 103 (2006), pp [GT98] D. Gilbarg and N. S. Trudinger, Elliptic Partial Differential Equations of Second Order, Springer-Verlag, Berlin, 2nd ed., [Ho01] M. Holst, Adaptive numerical treatment of elliptic systems on manifolds, Adv. Comput. Math., 15 (2001), pp (2002). A posteriori error estimation and adaptive computational methods. [MN05] K. Mekchay and R. H. Nochetto, Convergence of adaptive finite element methods for general second order linear elliptic PDEs, SIAM J. Numer. Anal., 43 (2005), pp (electronic). [MNS02] P. Morin, R. H. Nochetto, and K. G. Siebert, Convergence of adaptive finite element methods, SIAM Rev., 44 (2002), pp (electronic) (2003). Revised reprint of Data oscillation and convergence of adaptive FEM [SIAM J. Numer. Anal. 38 (2000), no. 2, (electronic); MR (2001g:65157)]. [Or05] F. A. Ortega, GMV Version 3.8, Tech. Rep. LA-UR , Los Alamos National Laboratory, August [SS05] A. Schmidt and K. G. Siebert, Design of adaptive finite element software, vol. 42 of Lecture Notes in Computational Science and Engineering, Springer-Verlag, Berlin, The finite element toolbox ALBERTA, With 1 CD-ROM (Unix/Linux). [Ver89] R. Verfürth, A posteriori error estimators for the Stokes equations, Numer. Math., 55 (1989), pp

Key words. Surface, interface, finite element, level set method, adaptivity, error estimator

Key words. Surface, interface, finite element, level set method, adaptivity, error estimator AN ADAPIVE SURFACE FINIE ELEMEN MEHOD BASED ON VOLUME MESHES ALAN DEMLOW AND MAXIM A. OLSHANSKII Abstract. In this paper we define an adaptive version of a recently introduced finite element method for

More information

L 2 and pointwise a posteriori error estimates for FEM for elliptic PDEs on surfaces

L 2 and pointwise a posteriori error estimates for FEM for elliptic PDEs on surfaces IMA Journal of Numerical Analysis 214) Page 1 of 27 doi:1.193/imanum/drn L 2 and pointwise a posteriori error estimates for FEM for elliptic PDEs on surfaces Fernando Camacho and Alan Demlow, Department

More information

R T (u H )v + (2.1) J S (u H )v v V, T (2.2) (2.3) H S J S (u H ) 2 L 2 (S). S T

R T (u H )v + (2.1) J S (u H )v v V, T (2.2) (2.3) H S J S (u H ) 2 L 2 (S). S T 2 R.H. NOCHETTO 2. Lecture 2. Adaptivity I: Design and Convergence of AFEM tarting with a conforming mesh T H, the adaptive procedure AFEM consists of loops of the form OLVE ETIMATE MARK REFINE to produce

More information

Projected Surface Finite Elements for Elliptic Equations

Projected Surface Finite Elements for Elliptic Equations Available at http://pvamu.edu/aam Appl. Appl. Math. IN: 1932-9466 Vol. 8, Issue 1 (June 2013), pp. 16 33 Applications and Applied Mathematics: An International Journal (AAM) Projected urface Finite Elements

More information

A finite element level set method for anisotropic mean curvature flow with space dependent weight

A finite element level set method for anisotropic mean curvature flow with space dependent weight A finite element level set method for anisotropic mean curvature flow with space dependent weight Klaus Deckelnick and Gerhard Dziuk Centre for Mathematical Analysis and Its Applications, School of Mathematical

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

A VOLUME MESH FINITE ELEMENT METHOD FOR PDES ON SURFACES

A VOLUME MESH FINITE ELEMENT METHOD FOR PDES ON SURFACES European Congress on Computational Methods in Applied Sciences and Engineering (ECCOMAS 2012) J. Eberhardsteiner et.al. (eds.) Vienna, Austria, September 10-14, 2012 A VOLUME MESH FINIE ELEMEN MEHOD FOR

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

Adaptive Finite Element Methods Lecture 1: A Posteriori Error Estimation

Adaptive Finite Element Methods Lecture 1: A Posteriori Error Estimation Adaptive Finite Element Methods Lecture 1: A Posteriori Error Estimation Department of Mathematics and Institute for Physical Science and Technology University of Maryland, USA www.math.umd.edu/ rhn 7th

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

On a Discontinuous Galerkin Method for Surface PDEs

On a Discontinuous Galerkin Method for Surface PDEs On a Discontinuous Galerkin Method for Surface PDEs Pravin Madhavan (joint work with Andreas Dedner and Bjo rn Stinner) Mathematics and Statistics Centre for Doctoral Training University of Warwick Applied

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

Maximum-norm a posteriori estimates for discontinuous Galerkin methods

Maximum-norm a posteriori estimates for discontinuous Galerkin methods Maximum-norm a posteriori estimates for discontinuous Galerkin methods Emmanuil Georgoulis Department of Mathematics, University of Leicester, UK Based on joint work with Alan Demlow (Kentucky, USA) DG

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

Intrinsic finite element modeling of a linear membrane shell problem

Intrinsic finite element modeling of a linear membrane shell problem arxiv:3.39v [math.na] 5 Mar Intrinsic finite element modeling of a linear membrane shell problem Peter Hansbo Mats G. Larson Abstract A Galerkin finite element method for the membrane elasticity problem

More information

A FINITE ELEMENT METHOD FOR ELLIPTIC EQUATIONS ON SURFACES

A FINITE ELEMENT METHOD FOR ELLIPTIC EQUATIONS ON SURFACES A FINITE ELEMENT METHOD FOR ELLIPTIC EQUATIONS ON SURFACES MAXIM A. OLSHANSKII, ARNOLD REUSKEN, AND JÖRG GRANDE Abstract. In this paper a new finite element approach for the discretization of elliptic

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

Intrinsic finite element modeling of a linear membrane shell problem

Intrinsic finite element modeling of a linear membrane shell problem RR Intrinsic finite element modeling of a linear membrane shell problem PETER HANSBO AND MATS G. LARSON School of Engineering Jönköping University Research Report No. : ISSN -8 Intrinsic finite element

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

Convergence and optimality of an adaptive FEM for controlling L 2 errors

Convergence and optimality of an adaptive FEM for controlling L 2 errors Convergence and optimality of an adaptive FEM for controlling L 2 errors Alan Demlow (University of Kentucky) joint work with Rob Stevenson (University of Amsterdam) Partially supported by NSF DMS-0713770.

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

Key words. Laplace-Beltrami operator, surface finite element methods, a posteriori error estimates, adaptive finite element methods

Key words. Laplace-Beltrami operator, surface finite element methods, a posteriori error estimates, adaptive finite element methods A POSTERIORI ERROR ESTIMATES FOR THE LAPLACE-BELTRAMI OPERATOR ON PARAMETRIC C 2 SURFACES ANDREA BONITO AND ALAN DEMLOW Key words. Laplace-Beltrami operator, surface finite element methods, a posteriori

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

Local pointwise a posteriori gradient error bounds for the Stokes equations. Stig Larsson. Heraklion, September 19, 2011 Joint work with A.

Local pointwise a posteriori gradient error bounds for the Stokes equations. Stig Larsson. Heraklion, September 19, 2011 Joint work with A. Local pointwise a posteriori gradient error bounds for the Stokes equations Stig Larsson Department of Mathematical Sciences Chalmers University of Technology and University of Gothenburg Heraklion, September

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

Chapter 6 A posteriori error estimates for finite element approximations 6.1 Introduction

Chapter 6 A posteriori error estimates for finite element approximations 6.1 Introduction Chapter 6 A posteriori error estimates for finite element approximations 6.1 Introduction The a posteriori error estimation of finite element approximations of elliptic boundary value problems has reached

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

Math 302 Outcome Statements Winter 2013

Math 302 Outcome Statements Winter 2013 Math 302 Outcome Statements Winter 2013 1 Rectangular Space Coordinates; Vectors in the Three-Dimensional Space (a) Cartesian coordinates of a point (b) sphere (c) symmetry about a point, a line, and a

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

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

An interpolation operator for H 1 functions on general quadrilateral and hexahedral meshes with hanging nodes

An interpolation operator for H 1 functions on general quadrilateral and hexahedral meshes with hanging nodes An interpolation operator for H 1 functions on general quadrilateral and hexahedral meshes with hanging nodes Vincent Heuveline Friedhelm Schieweck Abstract We propose a Scott-Zhang type interpolation

More information

A Stabilized Finite Element Method for the Darcy Problem on Surfaces

A Stabilized Finite Element Method for the Darcy Problem on Surfaces arxiv:1511.03747v1 [math.na] 12 Nov 2015 A Stabilized Finite Element Method for the Darcy Problem on Surfaces Peter Hansbo Mats G. Larson October 8, 2018 Abstract We consider a stabilized finite element

More information

1 Introduction and statements of results

1 Introduction and statements of results CONSTANT MEAN CURVATURE SURFACES WITH BOUNDARY IN EUCLIDEAN THREE-SPACE Rafael López 1 1 Introduction and statements of results The study of the structure of the space of constant mean curvature compact

More information

Analysis of a high order trace finite element method for PDEs on level set surfaces

Analysis of a high order trace finite element method for PDEs on level set surfaces N O V E M B E R 2 0 1 6 P R E P R I N T 4 5 7 Analysis of a high order trace finite element method for PDEs on level set surfaces Jörg Grande *, Christoph Lehrenfeld and Arnold Reusken * Institut für Geometrie

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

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

FINITE ELEMENT APPROXIMATION OF ELLIPTIC DIRICHLET OPTIMAL CONTROL PROBLEMS

FINITE ELEMENT APPROXIMATION OF ELLIPTIC DIRICHLET OPTIMAL CONTROL PROBLEMS Numerical Functional Analysis and Optimization, 28(7 8):957 973, 2007 Copyright Taylor & Francis Group, LLC ISSN: 0163-0563 print/1532-2467 online DOI: 10.1080/01630560701493305 FINITE ELEMENT APPROXIMATION

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

An a posteriori error estimate and a Comparison Theorem for the nonconforming P 1 element

An a posteriori error estimate and a Comparison Theorem for the nonconforming P 1 element Calcolo manuscript No. (will be inserted by the editor) An a posteriori error estimate and a Comparison Theorem for the nonconforming P 1 element Dietrich Braess Faculty of Mathematics, Ruhr-University

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

Stabilized Finite Element Approximation of the Mean Curvature Vector on Closed Surfaces

Stabilized Finite Element Approximation of the Mean Curvature Vector on Closed Surfaces arxiv:1407.3043v1 [math.na] 11 Jul 2014 Stabilized Finite Element Approximation of the Mean Curvature Vector on Closed Surfaces Peter Hansbo Mats G. Larson Sara Zahedi October 17, 2018 Abstract We develop

More information

Error estimates for the Raviart-Thomas interpolation under the maximum angle condition

Error estimates for the Raviart-Thomas interpolation under the maximum angle condition Error estimates for the Raviart-Thomas interpolation under the maximum angle condition Ricardo G. Durán and Ariel L. Lombardi Abstract. The classical error analysis for the Raviart-Thomas interpolation

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

Robust error estimates for regularization and discretization of bang-bang control problems

Robust error estimates for regularization and discretization of bang-bang control problems Robust error estimates for regularization and discretization of bang-bang control problems Daniel Wachsmuth September 2, 205 Abstract We investigate the simultaneous regularization and discretization of

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

1 Differentiable manifolds and smooth maps

1 Differentiable manifolds and smooth maps 1 Differentiable manifolds and smooth maps Last updated: April 14, 2011. 1.1 Examples and definitions Roughly, manifolds are sets where one can introduce coordinates. An n-dimensional manifold is a set

More information

An introduction to Mathematical Theory of Control

An introduction to Mathematical Theory of Control An introduction to Mathematical Theory of Control Vasile Staicu University of Aveiro UNICA, May 2018 Vasile Staicu (University of Aveiro) An introduction to Mathematical Theory of Control UNICA, May 2018

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

On Friedrichs inequality, Helmholtz decomposition, vector potentials, and the div-curl lemma. Ben Schweizer 1

On Friedrichs inequality, Helmholtz decomposition, vector potentials, and the div-curl lemma. Ben Schweizer 1 On Friedrichs inequality, Helmholtz decomposition, vector potentials, and the div-curl lemma Ben Schweizer 1 January 16, 2017 Abstract: We study connections between four different types of results that

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

Boundary Integral Equations on the Sphere with Radial Basis Functions: Error Analysis

Boundary Integral Equations on the Sphere with Radial Basis Functions: Error Analysis Boundary Integral Equations on the Sphere with Radial Basis Functions: Error Analysis T. Tran Q. T. Le Gia I. H. Sloan E. P. Stephan Abstract Radial basis functions are used to define approximate solutions

More information

CALCULUS ON MANIFOLDS. 1. Riemannian manifolds Recall that for any smooth manifold M, dim M = n, the union T M =

CALCULUS ON MANIFOLDS. 1. Riemannian manifolds Recall that for any smooth manifold M, dim M = n, the union T M = CALCULUS ON MANIFOLDS 1. Riemannian manifolds Recall that for any smooth manifold M, dim M = n, the union T M = a M T am, called the tangent bundle, is itself a smooth manifold, dim T M = 2n. Example 1.

More information

Numerical Approximation of Phase Field Models

Numerical Approximation of Phase Field Models Numerical Approximation of Phase Field Models Lecture 2: Allen Cahn and Cahn Hilliard Equations with Smooth Potentials Robert Nürnberg Department of Mathematics Imperial College London TUM Summer School

More information

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS JASON ALBRIGHT, YEKATERINA EPSHTEYN, AND QING XIA Abstract. Highly-accurate numerical methods that can efficiently

More information

arxiv: v1 [math.na] 12 Aug 2013

arxiv: v1 [math.na] 12 Aug 2013 ADAPTIVE FINITE ELEMENTS FOR SEMILINEAR REACTION-DIFFUSION SYSTEMS ON GROWING DOMAINS CHANDRASEKHAR VENKATARAMAN, OMAR LAKKIS, AND ANOTIDA MADZVAMUSE arxiv:138.449v1 [math.na] 1 Aug 13 Abstract. We propose

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

Centre for Mathematics and Its Applications The Australian National University Canberra, ACT 0200 Australia. 1. Introduction

Centre for Mathematics and Its Applications The Australian National University Canberra, ACT 0200 Australia. 1. Introduction ON LOCALLY CONVEX HYPERSURFACES WITH BOUNDARY Neil S. Trudinger Xu-Jia Wang Centre for Mathematics and Its Applications The Australian National University Canberra, ACT 0200 Australia Abstract. In this

More information

arxiv: v2 [math.na] 23 Apr 2016

arxiv: v2 [math.na] 23 Apr 2016 Improved ZZ A Posteriori Error Estimators for Diffusion Problems: Conforming Linear Elements arxiv:508.009v2 [math.na] 23 Apr 206 Zhiqiang Cai Cuiyu He Shun Zhang May 2, 208 Abstract. In [8], we introduced

More information

2 A Model, Harmonic Map, Problem

2 A Model, Harmonic Map, Problem ELLIPTIC SYSTEMS JOHN E. HUTCHINSON Department of Mathematics School of Mathematical Sciences, A.N.U. 1 Introduction Elliptic equations model the behaviour of scalar quantities u, such as temperature or

More information

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS JASON ALBRIGHT, YEKATERINA EPSHTEYN, AND QING XIA Abstract. Highly-accurate numerical methods that can efficiently

More information

ngsxfem: Geometrically unfitted discretizations with Netgen/NGSolve (https://github.com/ngsxfem/ngsxfem)

ngsxfem: Geometrically unfitted discretizations with Netgen/NGSolve (https://github.com/ngsxfem/ngsxfem) ngsxfem: Geometrically unfitted discretizations with Netgen/NGSolve (https://github.com/ngsxfem/ngsxfem) Christoph Lehrenfeld (with contributions from F. Heimann, J. Preuß, M. Hochsteger,...) lehrenfeld@math.uni-goettingen.de

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 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

SUPERCONVERGENCE PROPERTIES FOR OPTIMAL CONTROL PROBLEMS DISCRETIZED BY PIECEWISE LINEAR AND DISCONTINUOUS FUNCTIONS

SUPERCONVERGENCE PROPERTIES FOR OPTIMAL CONTROL PROBLEMS DISCRETIZED BY PIECEWISE LINEAR AND DISCONTINUOUS FUNCTIONS SUPERCONVERGENCE PROPERTIES FOR OPTIMAL CONTROL PROBLEMS DISCRETIZED BY PIECEWISE LINEAR AND DISCONTINUOUS FUNCTIONS A. RÖSCH AND R. SIMON Abstract. An optimal control problem for an elliptic equation

More information

Construction of a New Domain Decomposition Method for the Stokes Equations

Construction of a New Domain Decomposition Method for the Stokes Equations Construction of a New Domain Decomposition Method for the Stokes Equations Frédéric Nataf 1 and Gerd Rapin 2 1 CMAP, CNRS; UMR7641, Ecole Polytechnique, 91128 Palaiseau Cedex, France 2 Math. Dep., NAM,

More information

EXPOSITORY NOTES ON DISTRIBUTION THEORY, FALL 2018

EXPOSITORY NOTES ON DISTRIBUTION THEORY, FALL 2018 EXPOSITORY NOTES ON DISTRIBUTION THEORY, FALL 2018 While these notes are under construction, I expect there will be many typos. The main reference for this is volume 1 of Hörmander, The analysis of liner

More information

A Higher Order Finite Element Method for Partial Differential Equations on Surfaces

A Higher Order Finite Element Method for Partial Differential Equations on Surfaces A Higher Order Finite Element Method for Partial Differential Equations on Surfaces Jörg Grande and Arnold Reusken Preprint No. 403 July 2014 Key words: Laplace Beltrami equation, surface finite element

More information

An a posteriori error estimator for the weak Galerkin least-squares finite-element method

An a posteriori error estimator for the weak Galerkin least-squares finite-element method An a posteriori error estimator for the weak Galerkin least-squares finite-element method James H. Adler a, Xiaozhe Hu a, Lin Mu b, Xiu Ye c a Department of Mathematics, Tufts University, Medford, MA 02155

More information

ALEKSANDROV S THEOREM: CLOSED SURFACES WITH CONSTANT MEAN CURVATURE

ALEKSANDROV S THEOREM: CLOSED SURFACES WITH CONSTANT MEAN CURVATURE ALEKSANDROV S THEOREM: CLOSED SURFACES WITH CONSTANT MEAN CURVATURE ALAN CHANG Abstract. We present Aleksandrov s proof that the only connected, closed, n- dimensional C 2 hypersurfaces (in R n+1 ) of

More information

SYMMETRY RESULTS FOR PERTURBED PROBLEMS AND RELATED QUESTIONS. Massimo Grosi Filomena Pacella S. L. Yadava. 1. Introduction

SYMMETRY RESULTS FOR PERTURBED PROBLEMS AND RELATED QUESTIONS. Massimo Grosi Filomena Pacella S. L. Yadava. 1. Introduction Topological Methods in Nonlinear Analysis Journal of the Juliusz Schauder Center Volume 21, 2003, 211 226 SYMMETRY RESULTS FOR PERTURBED PROBLEMS AND RELATED QUESTIONS Massimo Grosi Filomena Pacella S.

More information

Enhancing eigenvalue approximation by gradient recovery on adaptive meshes

Enhancing eigenvalue approximation by gradient recovery on adaptive meshes IMA Journal of Numerical Analysis Advance Access published October 29, 2008 IMA Journal of Numerical Analysis Page 1 of 15 doi:10.1093/imanum/drn050 Enhancing eigenvalue approximation by gradient recovery

More information

Recovery-Based A Posteriori Error Estimation

Recovery-Based A Posteriori Error Estimation Recovery-Based A Posteriori Error Estimation Zhiqiang Cai Purdue University Department of Mathematics, Purdue University Slide 1, March 2, 2011 Outline Introduction Diffusion Problems Higher Order Elements

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

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 posteriori error estimates for Maxwell Equations

A posteriori error estimates for Maxwell Equations www.oeaw.ac.at A posteriori error estimates for Maxwell Equations J. Schöberl RICAM-Report 2005-10 www.ricam.oeaw.ac.at A POSTERIORI ERROR ESTIMATES FOR MAXWELL EQUATIONS JOACHIM SCHÖBERL Abstract. Maxwell

More information

A PLANAR SOBOLEV EXTENSION THEOREM FOR PIECEWISE LINEAR HOMEOMORPHISMS

A PLANAR SOBOLEV EXTENSION THEOREM FOR PIECEWISE LINEAR HOMEOMORPHISMS A PLANAR SOBOLEV EXTENSION THEOREM FOR PIECEWISE LINEAR HOMEOMORPHISMS EMANUELA RADICI Abstract. We prove that a planar piecewise linear homeomorphism ϕ defined on the boundary of the square can be extended

More information

Axioms of Adaptivity (AoA) in Lecture 3 (sufficient for optimal convergence rates)

Axioms of Adaptivity (AoA) in Lecture 3 (sufficient for optimal convergence rates) Axioms of Adaptivity (AoA) in Lecture 3 (sufficient for optimal convergence rates) Carsten Carstensen Humboldt-Universität zu Berlin 2018 International Graduate Summer School on Frontiers of Applied and

More information

SHARP BOUNDARY TRACE INEQUALITIES. 1. Introduction

SHARP BOUNDARY TRACE INEQUALITIES. 1. Introduction SHARP BOUNDARY TRACE INEQUALITIES GILES AUCHMUTY Abstract. This paper describes sharp inequalities for the trace of Sobolev functions on the boundary of a bounded region R N. The inequalities bound (semi-)norms

More information

A Spectral Method for Nonlinear Elliptic Equations

A Spectral Method for Nonlinear Elliptic Equations A Spectral Method for Nonlinear Elliptic Equations Kendall Atkinson, David Chien, Olaf Hansen July 8, 6 Abstract Let Ω be an open, simply connected, and bounded region in R d, d, and assume its boundary

More information

Scaling the Topology of Symmetric, Second-Order Planar Tensor Fields

Scaling the Topology of Symmetric, Second-Order Planar Tensor Fields Scaling the Topology of Symmetric, Second-Order Planar Tensor Fields Xavier Tricoche, Gerik Scheuermann, and Hans Hagen University of Kaiserslautern, P.O. Box 3049, 67653 Kaiserslautern, Germany E-mail:

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

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

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

More information

Weighted Regularization of Maxwell Equations Computations in Curvilinear Polygons

Weighted Regularization of Maxwell Equations Computations in Curvilinear Polygons Weighted Regularization of Maxwell Equations Computations in Curvilinear Polygons Martin Costabel, Monique Dauge, Daniel Martin and Gregory Vial IRMAR, Université de Rennes, Campus de Beaulieu, Rennes,

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

Implicit Functions, Curves and Surfaces

Implicit Functions, Curves and Surfaces Chapter 11 Implicit Functions, Curves and Surfaces 11.1 Implicit Function Theorem Motivation. In many problems, objects or quantities of interest can only be described indirectly or implicitly. It is then

More information

Key words. Laplace-Beltrami operator; finite element method; eigenvalues and eigenvector approximation; cluster approximation; geometric error

Key words. Laplace-Beltrami operator; finite element method; eigenvalues and eigenvector approximation; cluster approximation; geometric error A PRIORI ERROR ESTIMATES FOR FINITE ELEMENT APPROXIMATIONS TO EIGENVALUES AND EIGENFUNCTIONS OF THE LAPLACE-BELTRAMI OPERATOR ANDREA BONITO, ALAN DEMLOW, AND JUSTIN OWEN Abstract. Elliptic partial differential

More information

ON SOME ELLIPTIC PROBLEMS IN UNBOUNDED DOMAINS

ON SOME ELLIPTIC PROBLEMS IN UNBOUNDED DOMAINS Chin. Ann. Math.??B(?), 200?, 1 20 DOI: 10.1007/s11401-007-0001-x ON SOME ELLIPTIC PROBLEMS IN UNBOUNDED DOMAINS Michel CHIPOT Abstract We present a method allowing to obtain existence of a solution for

More information

Convergence Order Studies for Elliptic Test Problems with COMSOL Multiphysics

Convergence Order Studies for Elliptic Test Problems with COMSOL Multiphysics Convergence Order Studies for Elliptic Test Problems with COMSOL Multiphysics Shiming Yang and Matthias K. Gobbert Abstract. The convergence order of finite elements is related to the polynomial order

More information

Complex Analysis MATH 6300 Fall 2013 Homework 4

Complex Analysis MATH 6300 Fall 2013 Homework 4 Complex Analysis MATH 6300 Fall 2013 Homework 4 Due Wednesday, December 11 at 5 PM Note that to get full credit on any problem in this class, you must solve the problems in an efficient and elegant manner,

More information

FEM Convergence for PDEs with Point Sources in 2-D and 3-D

FEM Convergence for PDEs with Point Sources in 2-D and 3-D FEM Convergence for PDEs with Point Sources in -D and 3-D Kourosh M. Kalayeh 1, Jonathan S. Graf, and Matthias K. Gobbert 1 Department of Mechanical Engineering, University of Maryland, Baltimore County

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

Euler Characteristic of Two-Dimensional Manifolds

Euler Characteristic of Two-Dimensional Manifolds Euler Characteristic of Two-Dimensional Manifolds M. Hafiz Khusyairi August 2008 In this work we will discuss an important notion from topology, namely Euler Characteristic and we will discuss several

More information

SECOND ORDER TIME DISCONTINUOUS GALERKIN METHOD FOR NONLINEAR CONVECTION-DIFFUSION PROBLEMS

SECOND ORDER TIME DISCONTINUOUS GALERKIN METHOD FOR NONLINEAR CONVECTION-DIFFUSION PROBLEMS Proceedings of ALGORITMY 2009 pp. 1 10 SECOND ORDER TIME DISCONTINUOUS GALERKIN METHOD FOR NONLINEAR CONVECTION-DIFFUSION PROBLEMS MILOSLAV VLASÁK Abstract. We deal with a numerical solution of a scalar

More information

Introduction to Algebraic and Geometric Topology Week 14

Introduction to Algebraic and Geometric Topology Week 14 Introduction to Algebraic and Geometric Topology Week 14 Domingo Toledo University of Utah Fall 2016 Computations in coordinates I Recall smooth surface S = {f (x, y, z) =0} R 3, I rf 6= 0 on S, I Chart

More information

and finally, any second order divergence form elliptic operator

and finally, any second order divergence form elliptic operator Supporting Information: Mathematical proofs Preliminaries Let be an arbitrary bounded open set in R n and let L be any elliptic differential operator associated to a symmetric positive bilinear form B

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

A POSTERIORI ERROR ESTIMATION FOR NON-CONFORMING QUADRILATERAL FINITE ELEMENTS

A POSTERIORI ERROR ESTIMATION FOR NON-CONFORMING QUADRILATERAL FINITE ELEMENTS INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume 2, Number, Pages 8 c 2005 Institute for Scientific Computing and Information A POSTERIORI ERROR ESTIMATION FOR NON-CONFORMING QUADRILATERAL

More information

CURVATURE ESTIMATES FOR WEINGARTEN HYPERSURFACES IN RIEMANNIAN MANIFOLDS

CURVATURE ESTIMATES FOR WEINGARTEN HYPERSURFACES IN RIEMANNIAN MANIFOLDS CURVATURE ESTIMATES FOR WEINGARTEN HYPERSURFACES IN RIEMANNIAN MANIFOLDS CLAUS GERHARDT Abstract. We prove curvature estimates for general curvature functions. As an application we show the existence of

More information

Obstacle problems and isotonicity

Obstacle problems and isotonicity Obstacle problems and isotonicity Thomas I. Seidman Revised version for NA-TMA: NA-D-06-00007R1+ [June 6, 2006] Abstract For variational inequalities of an abstract obstacle type, a comparison principle

More information

A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators

A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators Jeff Ovall University of Kentucky Mathematics www.math.uky.edu/ jovall jovall@ms.uky.edu Kentucky Applied and

More information