Adaptive Finite Element Algorithms

Size: px
Start display at page:

Download "Adaptive Finite Element Algorithms"

Transcription

1 Adaptive Finite Element Algorithms of optimal complexity Adaptieve Eindige Elementen Algoritmen van optimale complexiteit (met een samenvatting in het Nederlands) PROEFSCHRIF ter verkrijging van de graad van doctor aan de Universiteit Utrecht op gezag van de rector magnificus prof. dr. W.H. Gispen, ingevolge het besluit van het college voor promoties in het openbaar te verdedigen op woensdag 18 oktober 2006 des middags te uur door YAROSLAV KONDRAYUK geboren op 12 juli 1977 te Khmelnitsk reg., Oekraine

2 Promotor: Co-promotor: Prof. dr. H.A. van der Vorst Dr. R.P. Stevenson Het onderzoek in dit proefschrift is financieel mogelijk gemaakt door de Nederlandse Organisatie voor Wetenschappelijk Onderzoek (NWO) Mathematics Subject Classification: 41A25, 65N12, 65N30, 65N50, 65Y20, 76M10 Yaroslav Kondratyuk Adaptive finite element algorithms of optimal complexity Proefschrift Universiteit Utrecht Met een samenvatting in het Nederlands ISBN

3 Contents 1 Introduction Scope of problems and motivations Navier-Stokes equations Linearized and stationary Navier-Stokes problem of Oseen type Stokes Problem hesis overview Chapter Chapter Chapter Chapter Analysis of Adaptive FE Algorithms for the Poisson Problem Abstract Variational Problem Galerkin Method Finite Element Approximation Spaces Local Mesh Refinement, Adaptivity and Optimal Complexity Algorithms Linear versus nonlinear and adaptive approximations Singular solutions of boundary value problems Nonconforming triangulations and hierarchical tree-structures Adaptive Algorithms of Optimal Complexity A Posteriori Error Analysis Basic Principle of Adaptive Error Reduction First Practical Convergent Adaptive FE Algorithm Second Practical Adaptive FE Algorithm Optimal Adaptive Algorithms Multiscale Decomposition of FEM Approximation Spaces Optimization of Adaptive riangulations Optimal Adaptive Finite Element Algorithm Numerical Experiments L-shaped domain Domain with a crack i

4 3 Adaptive FE Algorithms for Singularly Perturbed Problems Singularly Perturbed Reaction-Diffusion Equation Robust Residual Based A Posteriori Error Estimator Uniformly Convergent Adaptive Algorithm Numerical Example Derefinement-based Adaptive FE Algorithms for the Stokes Problem Introduction Mixed Variational Problems. Well-Posedness and Discretization Stokes Problem Methods of Optimal Complexity for Solving the Stokes Problem Derefinement/optimization of finite element approximation Derefinement of pressure approximation Derefinement of velocity approximation Adaptive Fixed Point Algorithms for Stokes Problem: Analysis and Convergence Convergent Adaptive Finite Element Algorithm for Inner Elliptic Problem Conclusions An Optimal Adaptive FEM for the Stokes Problem Introduction Stokes problem Finite element approximation Overview of the solution method A posteriori error estimators A posteriori error estimator for the inner elliptic problem A posteriori error estimator for the (reduced) Stokes problem Adaptive refinements resulting in error reduction Adaptive pressure refinements Adaptive velocity refinements An adaptive method for the Stokes problem in an idealized setting A practical adaptive method for the Stokes problem Numerical experiment Nederlandse samenvatting 139 Dankwoord/Acknowledgements 142 Curriculum Vitae 144

5

6 Chapter 1 Introduction his thesis is dedicated to the design and analysis of optimal algorithms for solving partial differential equations (PDEs). Recent tremendous progress in the performance of modern computers stimulated the development of efficient numerical methods. Modern numerical simulations employing large-scale computations provide a powerful approach for real-life problems. For the development of new numerical models, verification by means of rigorous mathematical analysis and numerical computations has become essential. he explanation by theoretical analysis, detailed analysis based on numerical computations, and also the comparison of these with real experiments, altogether usually guide the development of numerical models. Nevertheless, the most difficult problems, for instance turbulence in fluid flow, remain to be challenging problems for modern computers and numerical methods. In view of this, the design of optimal algorithms has received special attention in the numerical community. In this thesis, we are primarily interested in the development of efficient algorithms, with respect to computer memory usage and execution time, for solving numerically PDEs. Aiming for an optimal algorithm, we are naturally led to the so-called adaptive method. Simply speaking, the task of an adaptive method is to adapt the approximation to the unknown solution of a differential equation during the solution process, using only a posteriori information, and to produce eventually the (quasi-) best possible approximation with optimal computational costs. Nowadays adaptive finite element algorithms are being used to solve efficiently partial differential equations (PDEs) arising in science and engineering [40, 1, 3]. Adaptive methods are particularly efficient if the solution of a boundary value problem has singularities. he origin of a singularity can be a concentration of stresses in elasticity, boundary/internal layers in environmental pollution problems, or a propagation of shock-waves in fluid mechanics. he general structure of the loop of an adaptive algorithm is Solve Estimate Refine, Derefine. A fully adaptive finite element algorithm solves a discrete problem on some triangulation, estimates the error in the current approximation using an a posteriori error estimator and performs adaptive refinement of the triangulation in the regions where the error is largest. Using such an adaptive procedure, we work with a sequence of successively refined 1

7 triangulations with the objective to satisfy a stopping criterion based on the a posteriori error estimate with minimal computational effort. Despite the big success of adaptive FE methods in practical applications during the last 25 years, they were not even proven to converge in more than one space dimension before the works of Dörfler [19] (in 1996), and Morin, Nochetto, Siebert [29] (in 2000). Convergence alone, however, does not imply that the adaptive method is more efficient than its non-adaptive counterpart. Using the results concerning convergence, afterwards Binev, Dahmen and DeVore [6] (in 2004), and Stevenson [36] (in 2005) showed that adaptive FEMs converge with optimal rates and with linear computational complexity. hese first optimality results were based on the use of special mesh coarsening routines. In those references and in this thesis, an adaptive finite element method is called optimal if it performs as follows: whenever for some s > 0, the solution of boundary value problem can be approximated within a tolerance ε > 0, in energy norm, by a finite element approximation on some triangulation with O(ε 1/s ) triangles, and one knows how to approximate the right-hand side in the dual norm with the same rate, then the adaptive finite element method produces approximations that converge with this rate, with a number of operations that is of the order of the number of triangles in the output triangulation. 1.1 Scope of problems and motivations Navier-Stokes equations he Navier-Stokes problem (1.1.1) is a very difficult problem to solve numerically. u ν u + (u )u + p = f in Ω (0, ) t divu = 0 in Ω u = 0 on Ω (0, ) (1.1.1) ypically, the solutions of this problem show strong singularities, and the application of adaptive procedures is very valuable in this case. In view of the nonstationary behavior of singularities, a detailed analysis of optimality of local refinement/derefinement is necessary Linearized and stationary Navier-Stokes problem of Oseen type ypically, an Oseen problem (1.1.2) has to be solved at each step in the numerical approximation of the Navier-Stokes problem. ν u + (b )u + cu + p = f in Ω divu = 0 in Ω (1.1.2) u = 0 on Ω his problem too is computationally far from trivial, especially because of singular perturbations caused by the interactions between diffusion, convection and reaction terms. 2

8 o our knowledge, no complete analysis of optimal adaptive algorithms exists for this type of problem Stokes Problem he Stokes problem (1.1.3) is one of the main problems in this thesis, for which we study and develop optimal adaptive algorithms. u + p = f in Ω divu = 0 in Ω (1.1.3) u = 0 on Ω. 1.2 hesis overview Chapter 2 In this chapter we explain in detail the most important recent achievements in the theory of optimal adaptive FE algorithms, working with the Poisson problem. First, after recalling the basic properties of the finite element method, we consider the problem of approximation of a given function, and explain the notions of linear, nonlinear, and adaptive approximation. hen we explain why we may expect advantages of adaptive approximation for the numerical solution of partial differential equations. Furthermore, the construction and analysis of a posteriori error estimators is presented, and we discuss how to design a convergent adaptive method. We explain the notion of an optimal algorithm and present the construction of an algorithm that produces a sequence of approximations that converges with the optimal rate. Finally, we also present a proof for the optimal computational complexity of this adaptive algorithm. We wrote a C++ code implementing a 2D adaptive finite element solver. In this algorithm, Galerkin systems are solved with CG and a wavelet preconditioner. he solver has the possibility to switch between a nodal FEM basis and a wavelet basis on adaptive triangulations, when multiscale analysis of the solution is required. o demonstrate the performance of our solver, we present numerical examples for the Poisson problem on an L-shaped domain and on a domain with a crack Chapter 3 Here, we study adaptive algorithms for the singularly perturbed reaction-diffusion problem. Problems of this type arise, for example, in the modeling of thin plates, shells, in the numerical treatment of reaction processes, and as a result of an implicit time semidiscretization of parabolic or hyperbolic equations of second order. he main feature of the reaction-diffusion equation is that its solution exhibits very steep boundary layers for large values of the reaction term. In view of this, the application of adaptive methods to solve this problem is particularly attractive ([33, 42]). We are interested in adaptive methods that converge uniformly in terms of the reaction term. 3

9 he main ingredients of a robust solver for this kind of problem are discussed. In particular we present an analysis of a robust a posteriori error estimator and a uniform saturation property. We have implemented in C++ a 2D adaptive solver for the singularly perturbed reaction-diffusion problem. his solver constructs a sequence of adaptive approximations that converge uniformly in terms of the reaction term. Usually, it is quite difficult to achieve linear computational complexity for an adaptive algorithm in practice, because this requires a careful design and programming. We did numerical experiments that indicate that our adaptive solver is quite fast in operating with hundreds of thousands degrees of freedom and that it has linear computational complexity Chapter 4 his chapter and the paper [25] are dedicated to the design of optimal algorithms for the Stokes problem. ypically, problems in fluid mechanics (1.1.1), (1.1.2), (1.1.3) naturally lead to mixed variational problems [21, 11]. For the adaptive solution of mixed variational problems, the situation is much more complicated than for elliptic problems, and we are not aware of any proof of optimality of adaptive finite element algorithms. Bänch, Morin and Nochetto [5] introduced an adaptive FEM for the Stokes problem, and they proved convergence of the method. Since convergence alone does not imply that the adaptive method is more efficient than its non-adaptive counterpart, an analysis of the convergence rates is important. he numerical experiments in [5] show (quasi-) optimal triangulations for some values of the parameters, but a theoretical explanation of these results is still an open question. In [25] and in this chapter we present a detailed design of an adaptive FE algorithm for the Stokes problem, and analyze its computational complexity. As in [5], we apply a fixed point iteration to an infinite dimensional Schur complement operator. For the approximation of the inverse of the elliptic operator we use a generalization of the optimal adaptive finite element method from Chapter 2 for elliptic equations. By adding a derefinement step to the resulting adaptive fixed point iteration, in order to optimize the underlying triangulation after each fixed number of iterations, we show that the resulting method converges with the optimal rate and that it has optimal computational complexity. Apart from its use here, in our view, an efficient mesh optimization/derefinement routine could be very useful for the adaptive solution of nonstationary problems that exhibit moving shock waves Chapter 5 Recently, in the work of Stevenson [37], an adaptive FEM method was proposed for solving elliptic problems that has optimal computational complexity not relying on a recurrent derefinement of the triangulations. his result is very valuable for the construction of optimal adaptive algorithms for stationary problems. he extention of this result to the Stokes mixed variational problem appeared to be very complicated; it is the subject of this chapter (that presents a joint work with Stevenson [27]). 4

10 A new adaptive finite element method for solving the Stokes equations is developed, which is shown to converge with the best possible rate. he method consists of 3 nested loops. For a sequence of finite element spaces with respect to adaptively refined partitions, the solution is approximated in the outmost loop by that of the Stokes problem in which the divergence-free condition is reduced to orthogonality of the divergence to the finite element space in which the approximate pressure is sought. For solving each of these semi-discrete problems, the Uzawa iteration is applied. Finally, the elliptic system for the velocity that has to be solved in each Uzawa step is approximately solved by an adaptive finite element method. We have implemented this adaptive algorithm and we present a discussion of the numerical performance of our method for the Stokes problem on an L-shaped domain. We compare our results with those from an adaptive Uzawa method introduced by Bänch, Morin and Nochetto in [5]. 5

11 6

12 Chapter 2 Analysis of Adaptive FE Algorithms for the Poisson Problem 2.1 Abstract Variational Problem Let W be a real Hilbert space endowed with norm. W, and let W denote its dual space, i.e., the space of all bounded linear functionals f : W R equipped with the norm f W := Consider the following abstract variational problem (AVP) f(w) sup. (2.1.1) w W,w 0 w W Given f W, find u W such that (2.1.2) a(u, w) = f(w) for all w W. Definition A bilinear form a(.,.) : W W R is called continuous if there exists a constant ς > 0 such that a(u, w) ς u W w W for all u, w W. (2.1.3) Definition A bilinear form a(.,.) is called W -elliptic (or coercive), if there exists a constant α > 0 such that, a(w, w) α w 2 W for all w W. (2.1.4) he question about existence and uniqueness of the solution of (AVP) is answered by the Lax-Milgram lemma ([35, 13]): 7

13 Lemma (Lax-Milgram) Let W be a (real) Hilbert space, a(.,.) : W W R a bilinear, continuous and W-elliptic form, and f : W R be a bounded linear functional. hen there exists a unique solution u W to (AVP), and moreover where the constant α stems from the coercivity condition. u W 1 α f W, (2.1.5) Galerkin Method In the following let us assume that the conditions of the Lax-Milgram lemma hold. With the aim to build a numerical approximation to the solution of the abstract variational problem, we choose a sequence of subspaces (W j ) j N W, such that for all w W inf w w j W 0 as j. (2.1.6) w j W j For each W j W we can formulate the following discrete problem Given f W, find u j W j such that (2.1.7) a(u j, w j ) = f(w j ) for all w j W j. Since W j is a subspace of W, the conditions of Lax-Milgram lemma are true also for the discrete problem providing the existence and uniqueness of the discrete solution u j, that is called a Galerkin approximation. More precisely, its properties are stated in the following theorem([32]). heorem (Properties of a Galerkin approximation) Under the assumptions of the Lax-Milgram lemma, there exists a unique solution u j to (2.1.7). Furthermore it is stable, since independently of the choice of the subspace W j it satisfies Moreover, with u being the solution of (AVP), we have that u j W 1 α f W. (2.1.8) u u j W ς α inf w j W j u w j W. (2.1.9) In the following we consider the special case that the bilinear form a(.,.) is symmetric. he assumptions concerning symmetry, continuity and coercivity imply that we can introduce an energy inner product and energy norm induced by a(.,.): (u, w) E := a(u, w) for all u, w W, (2.1.10) 8

14 and the following norm equivalence holds u E := a(u, u) 1/2 for all u W, (2.1.11) α 1/2 u W u E ς 1/2 u W for all u W. (2.1.12) Now, let u and u j be the solutions of (AVP) and its discrete analog (2.1.7), respectively. Comparing (2.1.2) and (2.1.7) we infer that a(u u j, w j ) = 0 for all w j W j (2.1.13) showing that the error u u j of the Galerkin approximation is orthogonal to the approximation space W j with respect to the energy inner product. As a consequence, we have u w j 2 E = u j w j 2 E + u u j 2 E for all w j W, (2.1.14) and so the following lemma clearly holds true. Lemma If, in addition to the conditions of the Lax-Milgam lemma, the bilinear form a(.,.) : W W R is symmetric, then the Galerkin approximation u j, being the solution of (2.1.7), is the best approximation to the solution of (AVP) from the approximation space W j, i.e., u u j E = inf u w j E. (2.1.15) w j W j So note that in view of estimate (2.1.9) and property (2.1.6), we have lim u j = u in W. (2.1.16) j However, this result says nothing about the rate of convergence of the approximate solutions towards the exact one. For this we need additional information, namely, properties of the approximation spaces W j and the regularity of the solution. One of the possible choices for W j is provided by the finite element method. 2.2 Finite Element Approximation Spaces As we have seen in the previous section, to use the Galerkin method for the numerical solution of (AVP) we need to specify the approximation spaces W j. he finite element method is a specific procedure of constructing computationally efficient approximation spaces which are called finite element spaces. In many cases of practical interest we deal with a boundary value problem posed over a domain Ω R d with Lipschitz-continuous boundary. Depending on the boundary value problem under consideration, W is for example one of the spaces H 1 0(Ω), H 1 (Ω), H 2 0(Ω), H(div, Ω), H(curl, Ω) etc. Here we shall confine ourselves mostly to variational problems defined on H 1 0(Ω). his corresponds to 9

15 a second order elliptic boundary value problem. In particular, we start with the Poisson problem a(u, w) := Ω Given f H 1 (Ω) := (H 1 0(Ω)), find u H 1 0(Ω) such that (2.2.1) u w = f(w) for all w H 1 0(Ω) where we assume that the domain Ω is a polytope. he bilinear form a(, ) : H 1 0(Ω) H 1 0(Ω) R is continuous, coercive and symmetric. So on H 1 0(Ω), the H 1 0 (Ω)-norm and the energy-norm E differ at most a constant multiple. We switch between these norms at our convenience. Defining A : H 1 0(Ω) H 1 (Ω) by (A u)(w) = a(u, w), (2.2.1) can be rewritten as A u = f. (2.2.2) We will measure the error of any approximation for u in the energy norm E, with dual norm f(w) f E := sup, (f H 1 (Ω)). (2.2.3) 0 w H0 1(Ω) w E Equipped with these norms, A : H 1 0(Ω) H 1 (Ω) is an isomorphism. he first step within the finite element procedure is to produce a triangulation of the domain Ω ([12]), i.e., a finite collection of closed polytopes K (the elements ) such that Ω = K K the interior of each polytope K is non empty, i.e., int(k) for each pair of distinct K 1, K 2 one has int(k 1 ) int(k 2 ) = In view of constructing a sequence of subspaces (W j ) j N we will consider a sequence of triangulations ( j ) j N. Definition A sequence of triangulations ( j ) j N is called quasi-uniform if max diam(k) min diam(k). (2.2.4) K j K j Here and throughout the thesis, in order to avoid the repeated use of generic but unspecified constants, by C D we mean that C can be bounded by a multiple of D, independently of parameters which C and D may depend on, where in particular we think of j. Obviously, C D is defined as D C, and by C D we mean that C D and C D. Definition If for any pair of distinct polytopes K 1, K 2 with K 1 K 2, their intersection is a common lower dimensional face of K 1 and K 2, i.e., for d = 3 it is either a common face, side or vertex, then the triangulation is called conforming and otherwise we shall call it a nonconforming triangulation. A vertex of any K is called a vertex of. It is called a non-hanging vertex if it is a vertex for all K that contain it, otherwise it is called a hanging vertex (see Fig. 2.1). 10

16 Figure 2.1: Non-hanging and hanging vertices. Once we set up the triangulation j, the next step is to construct the corresponding approximation space W j. For some k N >0, for each element K j let P (K) be a space of algebraic polynomials of some fixed finite dimension that includes the space P k (K) of all polynomials of total degree less or equal to k. We define W j := {v C r (Ω) K j P (K) : v Ω = 0} (2.2.5) where r { 1, 0, 1, } and C 1 (Ω) := L 2 (Ω). Depending on k and of the type of polytopes being used, the space P (K) will be chosen to be sufficiently large such that, despite of the intersection with C r (Ω), the following direct or Jackson estimate is valid: For all p [1, ], s t k + 1, s < r + 1 p inf u w j W s w j W p (Ω) h t s j u W t p (Ω) for all u W t j p(ω) (2.2.6) where h j := max K j diam(k). Since measured in L 2 (Ω), the error behaves at best like O(h k+1 ), the space W j is said to have order k + 1. Defining, for a triangulation, A : W (W ) H 1 (Ω) by (A v )(w ) = a(v, w ) for v, w W, u := A 1 f is the Galerkin approximation of u. One easily verifies that for any f H 1 (Ω), A 1 f E f E. Definition If, for each polytope K j, the ratio of the radii of the smallest circumscribed and the largest inscribed ball of K is bounded uniformly in K j and j N, then the sequence of triangulations ( j ) j N is called shape-regular. In finite element analysis we need the shape regularity requirement to avoid very small angles in the triangulation since typical FEM estimates depend on the minimal angle of the triangulation and deteriorate when it becomes small. For a shape regular sequence of triangulations, we have the following inverse or Bernstein estimate (e.g., [31]): With h j := min K j diam(k) and s t < r + 1 p, w j W t p (Ω) h s t j w j W s p (Ω) for all w j W j. (2.2.7) Since W 1 2 (Ω) = H 1 (Ω), note that the Bernstein inequality in particular implies that for r = 0, the space W j defined in (2.2.5) is contained in H 1 0(Ω). herefore, in the following 11

17 we may confine the discussion to the case r = 0. Furthermore, as elements we will consider exclusively d-simplices, i.e., triangles for d = 2 and tetrahedra for d = 3. Finally, as spaces P (K) we consider P k (K) for some k N >0. hat is, for some triangulations j of Ω R d into d-simplices, we consider W j := H 1 0(Ω) C(Ω) K j P k (K). (2.2.8) In order to perform efficient computations with this space we need a basis consisting of functions that have supports that are as small as possible. For this goal, we will first select a set {a i : i J j } of points in Ω such that each u W j is uniquely determined by its values at these points, and, conversely, that for each c = (c i ) i Jj R J j there is a w j W j with w j (a i ) = c i, i J j. We will call such a set a nodal set. For each K j we select the set of points S K = {x K : λ K (x) k 1 N d+1 }, (2.2.9) where λ K (x) R d+1 are the barycentric coordinates of x with respect to K, see Figures 2.2, 2.3, 2.4. Now, assuming that j is conforming, a nodal set is the union of these sets, excluding those on the boundary of Ω. Indeed, note that each p P k (K) is uniquely determined by its values in the points from the set S K. hen the statement follows from the fact that for u W j the degrees of freedom on each face of K j uniquely identify the restriction of u to that face. Given a nodal set {a i : i J j }, we define a corresponding basis {φ i : i J j } W j by { 1 if i = m φ i (a m ) = (2.2.10) 0 if i m. he set {φ i : i J j } is called a nodal basis and each w j W j can be uniquely represented as w j = i J j w j (a i )φ i. (2.2.11) In case of a possibly nonconforming triangulation, we define the nodal set as {x K j S K x / Ω and if x K j then x S K }. (2.2.12) he basis for W j is then again defined by (2.2.10). For each w C(Ω) we define the nodal interpolant I j w = i J j w(a i )φ i. (2.2.13) he following theorem gives estimates for the interpolation error w I j w ([31, 13]) 12

18 Figure 2.2: Sets S K in 2D and 3D for k = 1 Figure 2.3: Sets S K in 2D and 3D for k = 2 heorem Let ( j ) j N be a shape-regular sequence of triangulations. hen w I j w W s p (Ω) h t+1 s j w W t+1 p (Ω) for all w W t+1 p (Ω), (2.2.14) for parameters s, t and p as in (2.2.6) (and r = 0), with the additional condition t + 1 > d p. Remark Note that this theorem implies (2.2.6) for t + 1 > d. o obtain (2.2.6) p without this additional condition, one can apply so-called quasi-interpolants ([31, 14]). Finally we note that in case the domain Ω is not a polytope, in order to provide a good approximation of the boundary of Ω, isoparametric elements are used, which have curved boundaries. For more details about the construction of finite element spaces we refer the reader to the books ([13, 9, 2, 32, 10]). 2.3 Local Mesh Refinement, Adaptivity and Optimal Complexity Algorithms Approximation of a given function. Linear versus nonlinear and adaptive approximations In this section, as an example to illustrate ideas, we consider the problem of approximating a given function f : Ω R by piecewise constant functions, where Ω := [0, 1]. For 13

19 Figure 2.4: Sets S K in 2D and 3D for k = 3 W L (Ω), by e(f, W ) we denote the error in uniform norm (L -norm) of the best approximation of f by elements of W, i.e., e(f, W ) := inf w W f w L (Ω). (2.3.1) We will describe here three types of approximation, namely linear, nonlinear and adaptive. Let be a triangulation of Ω, i.e., a finite collection of essentially disjoint closed subintervals K such that Ω = K K. Let W 0 ( ) be the space of piecewise constant functions relative to, i.e., W 0 ( ) := P 0 (K). (2.3.2) K Let us first consider a uniform triangulation, meaning that all subintervals have equal length. From the estimate (2.2.6) we infer that inf f w L w W 0 (Ω) 1 u W 1 (Ω) for all f W (Ω), 1 (2.3.3) ( ) i.e., the optimal order 1 for piecewise constant approximation is attained for f W 1 (Ω). What is more, in ([18]) it is shown that e(f, W 0 ( )) α f Lip(α, L (Ω)). (2.3.4) Here, the space Lip(α, L p (Ω)), 0 < α 1, 0 < p is the space of all functions f L p (Ω) for which f( + h) f( ) Lp[0,1 h) Mh α, 0 < h < 1 (2.3.5) with the smallest M 0 for which (2.3.5) holds being the norm f Lip(α,Lp(Ω)). he space Lip(α, L (Ω)) is equal to W (Ω). 1 hanks to (2.3.4), we know precisely which class of functions can be approximated with order α by piecewise constants on uniform triangulations. his type of approximation where the triangulations are chosen in advance and are independent of the target function f is called linear. 14

20 Another type of approximation is nonlinear approximation. Nonlinear approximation allows the triangulations of Ω to depend on f. Let W 0 NL(n) :=, =n W 0 ( ), (2.3.6) i.e., the space of piecewise constants with respect to some partition of [0, 1] into n subintervals, which, clearly, is not a linear space. Whereas for linear approximation the optimal order 1 is attained for functions f Lip(1, L (Ω)), as shown in ([18]) the nonlinear approximation provides the optimal order for f Lip(1, L 1 (Ω)), i.e., e(f, W 0 NL(n)) n 1 f Lip(1, L 1 (Ω)). (2.3.7) Since Lip(1, L 1 (Ω)) is a much larger space than Lip(1, L (Ω)), with nonlinear approximation it is possible to realize the optimal approximation order for a much larger class of functions. Note, however, that the sequence of underlying optimal triangulations is not explicitly given. he third type of approximation we discuss is adaptive approximation. his is a kind of nonlinear approximation given by an algorithm that, as we will see, produces a sequence of piecewise constant approximations that converges with the optimal order under only slightly stronger conditions on f than needed for (best) nonlinear approximations. Since this is the first adaptive algorithm that we mention here, we will discuss it in some detail. Given ε, which is the target accuracy of the approximation, the adaptive algorithm ADAP- IVE subdivides those elements K for which the error inf P0 (K) R f c L (K) ε into two equal parts until the desired tolerance is met. Algorithm 2.1 Adaptive Algorithm ADAPIVE[f, ε, K] /* Called with K = [0, 1], the output of the algorithm is the triangulation such that e(f, W 0 ( )) ε. */ if inf c R f c L (K) > ε then Subdivide K into two equal parts K 1 and K 2. 1 :=ADAPIVE[f, ε, K 1 ] 2 :=ADAPIVE[f, ε, K 2 ] := 1 2 endif In [18] it was shown that this adaptive algorithm attains the optimal approximation order 1 if f satisfies the condition f L log L, where L log L stands for the space of all integrable functions g for which g L log L := g(x) (1 + log g(x) )dx <. (2.3.8) Ω his space is only slightly smaller than Lip(1, L 1 (Ω)), membership of which was needed for convergence of order 1 with best partitions. As an illustration, we consider the following example. 15

21 1 Nonlinear approximation for y=x 1/ y x Figure 2.5: Example Let us consider the function f(x) = x α with 0 < α < 1. Since it belongs to Lip(α, L (Ω)), whereas it doesn t belong to a higher order Lipschitz space, in view of (2.3.4), this function can be approximated on uniform triangulations with order exactly α, i.e., e(f, W 0 ( )) α. (2.3.9) In particular, the optimal order 1 can not be attained by linear approximation. Noting that f Lip(1, L 1 (Ω)), we conclude that this function can be approximated with order 1 using nonlinear approximation. Indeed, choose the points x k := (k/n) 1/α, k = 0, 1,..., n, which are preimages of y k := (k/n), k = 0, 1,..., n (see Fig. 2.5, Fig. 2.6). hen, with = {[x i, x i+1 ]} n 1 i=0 one easily verifies that e(f, W 0 NL(n)) e(f, W 0 ( )) 1/n, (2.3.10) i.e., with nonlinear approximation the optimal order 1 is attained for any 0 < α < 1. Finally what is more, since for any α (0, 1), f L log L, this optimal order is also attained by the algorithm ADAPIVE Singular solutions of boundary value problems In the previous section, we discussed the problem of approximating a given function. he situation is more complicated if we want to construct an algorithm for the numerical solution of a boundary value problem, since the solution is unknown and can have a singularity somewhere in the domain Ω. he origin of a singularity can be a concentration 16

22 1 Nonlinear approximation for y=x 1/ y x Figure 2.6: of stresses in elasticity, boundary/internal layers in environmental pollution problems, or a propagation of shock-waves in fluid mechanics ([4, 20, 33]). As an example, let us consider the Poisson problem (2.2.1) in two space dimensions, where Ω is a polygon (Fig. (2.7)), and the right-hand side is sufficiently smooth. hen it is known ([2]) that the regularity of the solution u depends on the maximum interior angle ω at the corners in the boundary of the domain. More precisely, for any ε > 0 we have u H π/ω+1 ε (Ω), whereas generally u / H π/ω+1 (Ω). (2.3.11) Consider now the finite element spaces W j from (2.2.5) of order k + 1 with respect to a sequence of quasi-uniform triangulations ( j ) j N. From (2.2.6), with N j := j h 2 j we infer that inf u w j H w j W 1 (Ω) N k/2 j u H k+1 (Ω) for all u H k+1 (Ω) (2.3.12) j We conclude that the optimal order k/2 is attained if u H k+1 (Ω). Actually, one can show that this is sharp, so that from (2.3.11) we see that the rate of such finite element approximations is not restricted by the regularity of the solution only if ω π/k. For k 4, there is no polygon that satisfies this condition. For k = 3, it is only satisfied for an equilateral triangle, and for k = 1, it requires that there are no re-entrant corners. o handle the case that ω > π/k, algorithms based on adaptive triangulations are often proposed with the aim to retain the optimal rate of convergence. We are interested in the question whether such adaptive procedures can really lead to a significant improvement of the numerical efficiency. An example of a typical adaptive finite element mesh for the problem with a corner singularity is given in Fig

23 Figure 2.7: Polygon with maximum interior angle ω Figure 2.8: ypical adaptive finite element mesh for a problem with a corner singularity 18

24 2.3.3 Nonconforming triangulations and adaptive hierarchical treestructures As we have described before, finite element spaces consist of suitable subspaces of all piecewise polynomials of a certain degree with respect to a subdivision of Ω into a large number of tiny polytopes. Here, we will consider such approximation spaces based on subdivisions into triangles, so in two space dimensions. In this section, we describe the type of triangulations that we shall use throughout this chapter. Let be a triangulation of Ω. Recall from Definition the concepts of conforming and nonconforming triangulations and hanging and non-hanging vertices of. We shall say that an edge l of a triangle K is an edge of the triangulation if it doesn t contain a hanging vertex in its interior. he set of all edges of will be denoted by Ē, and the set of all non-hanging vertices of by V. he set of all interior edges of and the set of all interior non-hanging vertices of will be denoted by E and V respectively. If two triangles K 1, K 2 share some edge l E, they will be called edge neighbors, and if they share a vertex we will call them vertex neighbors. An adaptive algorithm will produce generally locally refined meshes. In view of the importance of having shape-regular triangulations, the question arises which local refinement strategies preserve shape regularity. he following three methods are known to do so: Regular or red-refinement. he red refinement strategy consists of subdividing a triangle by connecting the midpoints of its edges. Clearly, since we start with a nondegenerate triangulation 0, subdivision based on red refinement produces a shape regular family of triangulations. Longest edge bisection. his strategy subdivides a triangle by connecting the midpoint of the longest edge with the vertex opposite to this edge. In ([34]) it was proven that in each triangulation from any sequence 1..., n built by the longest edge bisection, the smallest angle is larger than or equal to half of the smallest angle in the initial triangulation 0. Newest vertex bisection. his strategy starts with assigning to exactly one vertex of each triangle in the initial triangulation 0 the newest vertex label. hen if at some step of the adaptive algorithm triangle K should be subdivided, we perform this by connecting the newest vertex of K with the opposite edge, and mark the midpoint of this edge as the newest vertex for both new triangles produced by this subdivision. In ([28]) it was proven that the refinement based on newest vertex bisection builds a family of triangulations which is shape regular. In this chapter we restrict ourselves to triangulations that are created by (recursive), generally non-uniform red-refinements starting from some fixed initial conforming triangulation 0. Generally these triangulations are generally nonconforming. For reasons that will become clear later (in Section 2.8.1), we will have to limit the amount of nonconformity by restricting ourselves to admissible triangulations, a concept that is defined as follows: 19

25 Figure 2.9: riangle and its red-refinement. Figure 2.10: An example of admissible triangulation. Definition A triangulation is called an admissible triangulation if for every edge of a K that contains a hanging node in its interior, the endpoints of this edge are nonhanging vertices. Figure 2.10 depicts an example of an admissible triangulation. Apparently local refinement produces triangulations which are generally not admissible. In the following we discuss how to repair this. o any triangle K from the initial triangulation 0 we assign the generation gen(k) = 0. hen the generation gen(k) for K is defined as the number of subdivision steps needed to produce K starting from the initial triangulation 0. A triangulation is called uniform when all triangles have the same generation. A vertex of the triangulation will be called a regular vertex if all triangles that contain this vertex have the same generation (see Fig. 2.11). Obviously, a regular vertex is non-hanging. Corresponding to the triangulation, we build also a tree ( ) that contains as nodes all the triangles which were created to construct from 0. he roots of this tree are the triangles of the initial triangulation 0. When a triangle K is subdivided, four new triangles appear which are called children of K, and K is called their parent. Similarly, we 20

26 Figure 2.11: A regular (left picture) and a non-regular although non-hanging vertex (right picture). introduce also grandparent/grandchildren relations. In case a triangle K ( ) has no children in the tree ( ), it is called a leaf of this tree. he set of all leaves of the given tree ( ) will be denoted by L( ( )). Apparently, the set of leaves L( ( )) forms the final triangulation. We will call a subtree of, denoted as, if it contains all roots of and if for any K all its siblings and ancestors are also in. Proposition [36] For any triangulation created by red-refinements starting from 0, there exists a unique sequence of triangulations 0, 1..., n with max K i gen(k) = i, n = and where i+1 is created from i by refining some K i with gen(k) = i. Let 1 = and V 1 =. he following properties are valid: n i=0 i 4 3, V i 1 V i and so V = n i=0v i \ V i 1 with empty mutual intersections, a v V i \ V i 1 is not a vertex of i 1, and so it is a regular vertex of i As we noted before, in case we refine some admissible triangulation only locally, the admissibility of the triangulation might be destroyed. If a given triangulation is not admissible (see Fig. 2.12), it can be completed to an admissible triangulation using the following algorithm. his algorithm makes use of the sequence 0,..., n corresponding to the input triangulation as defined in Proposition Algorithm 2.2 Make Admissible MakeAdmissible[ ] 1. a 0 := 0 2. Let i := 0 3. Define a i+1 as the union of i+1 and, when i n 2, the collection of children of those K a i that have a vertex neighbor in i with grandchildren in i+2 4. If i n 2 then i + + and go to step (3). Otherwise set := a n and stop. 21

27 Figure 2.12: An example of a non-admissible triangulation (left) and its smallest admissible refinement (right). Proposition [36] he triangulation a admissible refinement of. Moreover, constructed by MakeAdmissible is an a (2.3.13) Adaptive Algorithms of Optimal Complexity For ( i ) i being the family of all triangulations that can be constructed from a fixed initial triangulation 0 of Ω by red-refinements, let (W i ) i, (Y i ) i be the families of finite element approximation spaces defined by W i := {v C(Ω) K i P 1 (K) : v Ω = 0}, (2.3.14) Y i := K i P 0 (K). (2.3.15) he spaces Y i will be used for approximating the right-hand side of our equation. he reason for their introduction will become clear clear in the next section where we discuss a posteriori error estimators. Defining for any S H 1 0(Ω) and w H 1 0(Ω) e(w, S) H 1 0 (Ω) := inf w S w w H 1 0 (Ω), (2.3.16) the error of the best approximation from the best space W i with underlying triangulation consisting of n + 0 triangles is given by σ H1 0 (Ω) n (w) = inf i ( j ) j, i 0 n e(w, W i ) H 1 0 (Ω) (2.3.17) We now define classes for which the errors of the best approximations from the best spaces decay with certain rates. Definition For any s > 0, let A s (H 1 0(Ω)) = A s (H 1 0(Ω), (W i ) i ) be the class of functions w H 1 0(Ω) such that for some M > 0 σ H1 0 (Ω) n (w) Mn s n = 1, 2,.... (2.3.18) 22

28 We equip A s (H 1 0(Ω)) with a semi-norm defined as the smallest M for which (4.4.6) holds: and with norm w A s (H0 1(Ω)) := sup n s σ H1 0 n (Ω) (w), (2.3.19) n 1 w A s (H 1 0 (Ω)) := w A s (H 1 0 (Ω)) + w H 1 0 (Ω). (2.3.20) For approximating the right-hand side of our boundary value problem, in a similar way we define also the class A s (H 1 (Ω)) = A s (H 1 (Ω), (Y i ) i ) using the approximation space (Y i ) i. he goal of adaptive approximation is to realize the rates of the best approximation from the best spaces. We note here that a rate s > 1/2 only occurs when the approximated function is exceptionally close to a finite element function, and such a rate can not be enforced by imposing whatever smoothness condition. From now on we consider the case s 1/2. Below we sketch why we expect, similar to section 2.3.1, better results with adaptive approximation than with non-adaptive approximation based on uniform refinements. In order to do so, we temporarily consider the family of triangulations generated by newest vertex bisection. We expect however similar results to be valid with red refinements. Let ( i ) i be the family of all triangulations created by newest vertex bisections from an initial triangulation 0 and let X i := C(Ω) K i P 1 (K). (2.3.21) For simplicity, to illustrate the ideas, we dropped here the Dirichlet boundary conditions. Recently, in [6] it was shown that the approximation classes A s (H 1 (Ω), (X i ) i ) are (nearly) characterised by membership of certain Besov spaces: heorem (i) If u Bτ 2s+1 (L τ (Ω)) with 0 s 1/2 and 1/τ < s + 1/2 then u A s (H 1 (Ω), (X i ) i ) and u A s (H 1 (Ω),(X i ) i ) u B 2s+1 τ (L τ (Ω)) (2.3.22) (ii) if u A s (H 1 (Ω), (X i ) i ) then u B 2s+1 τ (L τ (Ω)), where 1/τ = s + 1/2. On the other hand, as is well-known, in two space dimensions and with piecewise linear approximation a rate s 1/2 is attained by approximations on uniform triangulations if and only if the approximated function belongs to H 2s+1 (Ω). he above result shows that a rate s 1/2 is achieved by the best approximation from the best spaces for any function from the much larger spaces Bτ 2s+1 (L τ (Ω)) for any τ > (s + 1/2) 1. Although these results were stated for the triangulations created by newest vertex bisections, as we said we expect the same results to be valid for the family of triangulations constructed by red-refinements. he difference between Sobolev spaces and Besov spaces is well illustrated by the DeVore diagram (Fig. 2.13). In this diagram, the point (1/τ, r) represents the Besov space Bτ(L r τ (Ω)). Since B2(L r 2 (Ω)) = H r (Ω), the Sobolev spaces H r (Ω) corresponds to the points (1/2, r). From this diagram we can observe that the larger s is, the larger is the space Bτ 2s+1 (L τ (Ω)) with τ = (s + 1/2) 1 compared to H 2s+1 (Ω). 23

29 o solve the Poisson problem (2.2.1) numerically, we need to be able to approximate the right-hand side within any given tolerance. We assume the availability of the following routine RHS. Algorithm 2.3 RHS RHS[, f, ε] [, f ] /* Input of the routine: triangulation f H 1 (Ω) ε > 0 Output: admissible triangulation and an f Y such that f f H 1 (Ω) ε */ As in [36], we will call the pair (f, RHS) to be s-optimal if there exists an absolute constant c f > 0 such that for any ε > 0 and triangulation, the call of the algorithm RHS performs such that both and the number of flops required by the call are + c 1/s f ε 1/s (2.3.23) Apparently, for a given s, such a pair can only exist if f A s (H 1 (Ω), (Y i ) i ). A realisation of the routine RHS depends on the right-hand side at hand. As it was shown in [36], for f L 2 (Ω), RHS can be based on uniform refinements. We will say that an adaptive method is optimal if it produces a sequence of approximations with respect to triangulations with cardinalities that are at most a constant multiple larger then the optimal ones. More precisely, we define Definition Suppose that the solution of the Poisson problem (2.2.1) is such that u A s (H0(Ω)) 1 for some s > 0 and there exists a routine RHS such that the pair (f, RHS) is s-optimal. hen we shall say that an adaptive method is optimal if for any ε > 0 it produces a triangulation j from the family ( i ) i with j ε 1/s ( u 1/s A s (H c1/s (Ω)) f ) and an approximation w j W j with u w j H 1 0 (Ω) ε taking only ε 1/s ( u 1/s A s (H0 1(Ω))+c1/s f ) flops. Note that in view of the assumption u A s, a cardinality of j equal to ε 1/s u 1/s A s (H 1 0 (Ω)) is generally the best we can expect. he questions that should be answered, being the topics of our discussions in the next sections, are How to construct an a posteriori error estimator that provides reliable error control during the adaptive approximation process? How to construct a convergent adaptive strategy? 24

30 r (1/2,r) (1/τ, r) B r τ (L τ ), 1/τ = r/2 (1/2,1) H 1 (Ω) (0,0) 1/τ Figure 2.13: DeVore diagram. On the vertical line are the spaces H r (Ω), and on the skew line are the spaces B r τ(l τ (Ω)) with r = 2s + 1 and τ = (1/2 + s) 1, i.e., r = 2/τ 25

31 How to ensure that our adaptive approximation is optimal in the above sense? How to design the computer implementation of the adaptive algorithm which use CPU, memory etc. also in an optimal way? 2.4 A Posteriori Error Analysis In this section we will apply the elegant technique developed by Verfürth ([41]) to construct and analyze an a posteriori error estimator for the case of nonconforming triangulations. Moreover, with this technique we will be able to prove the so called saturation property which, as we will show in the next section, is essential for realizing a convergent adaptive method. hinking of an adaptive algorithm for solving the boundary value problem (2.2.1), we draw the attention of the reader to the algorithm ADAPIVE. Note that this algorithm for approximating a given function is based on the full knowledge of the error. When solving a boundary value problem, however, we do not know the solution u and thus the error. Given the Galerkin approximation u, from (2.2.1) we can derive the following equation for the error e := u u find e H 1 0(Ω) such that (2.4.1) a(e, w) = f(w) a(u, w) for all w H 1 0(Ω). his problem is as expensive to solve as the initial one. However, we have the discrete approximation u and right hand side f H 1 (Ω) in our hands. his information can be used to create an a posteriori error estimator E(, f, u ). he important requirements on the estimator E are: Reliability. here exists a constant C U > 0 such that u u E C U E (2.4.2) Efficiency. he estimator is called efficient if there exists a constant C L > 0 such that C L E u u E (2.4.3) Remark A quantitative characterization of the estimator is given by the global effectivity index defined by E I effectivity = (2.4.4) u u E In view of the characterization u u E = a(u u, w) sup, (2.4.5) 0 w H0 1(Ω) w E 26

32 and assuming that f L 2 (Ω), using integration by parts, we write a(u u, w) = fw u w Ω Ω = {f + u }w [ u ]w (2.4.6) K K l E l ν l = R K w R l w, K K l E l where R K is an element residual and R l denotes an edge residual R K = R K (f) := (f + u ) K, (2.4.7) R l = R l (u ) := [ u ν l ]. (2.4.8) Here for l E, ν l is a unit vector orthogonal to l, and with l separating two elements K 1, K 2, [ w w w ](x) := lim (x + tν l ) lim (x tν l ) for all x l. (2.4.9) ν l t 0+ ν l t 0+ ν l is the jump of the normal derivative over l. Note here that, since we consider the case that u is linear, u = 0, so that indeed R K only depends on f. Having these quantities in our hands we are ready to set an a posteriori error estimator E(, f, w ) = [ K diam(k) 2 R K 2 L 2 (K) + l E diam(l) R l 2 L 2 (l)] 1/2. Before stating the theorem about our error estimator, we need to recall one more result, that will be invoked in the proof. In [36] a piecewise linear (quasi)-interpolant was constructed on admissible triangulations for H 1 0(Ω) functions. Its properties are stated in the following theorem. heorem Let be an admissible triangulation of Ω. hen there exists a linear mapping I : H0(Ω) 1 W such that w I w H s (K) diam(k) 1 s w H 1 (Ω K ) (w H 1 0(Ω), s = 0, 1, K ) (2.4.10) w I v L2 (l) diam(l) 1/2 w H 1 (Ω Kl ) (w H 1 0(Ω), l E ) (2.4.11) where for each K, Ω K is the union of uniformly bounded collection of triangles in, among them K, which is simply connected and satisfies diam(ω K ) diam(k), and where for l E, K l is a triangle that has edge l. 27

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

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

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

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

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

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

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

Multigrid Methods for Elliptic Obstacle Problems on 2D Bisection Grids

Multigrid Methods for Elliptic Obstacle Problems on 2D Bisection Grids Multigrid Methods for Elliptic Obstacle Problems on 2D Bisection Grids Long Chen 1, Ricardo H. Nochetto 2, and Chen-Song Zhang 3 1 Department of Mathematics, University of California at Irvine. chenlong@math.uci.edu

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

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

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

More information

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

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 optimal adaptive finite element method. Rob Stevenson Korteweg-de Vries Institute for Mathematics Faculty of Science University of Amsterdam

An optimal adaptive finite element method. Rob Stevenson Korteweg-de Vries Institute for Mathematics Faculty of Science University of Amsterdam An optimal adaptive finite element method Rob Stevenson Korteweg-de Vries Institute for Mathematics Faculty of Science University of Amsterdam Contents model problem + (A)FEM newest vertex bisection convergence

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 very short introduction to the Finite Element Method

A very short introduction to the Finite Element Method A very short introduction to the Finite Element Method Till Mathis Wagner Technical University of Munich JASS 2004, St Petersburg May 4, 2004 1 Introduction This is a short introduction to the finite element

More information

QUASI-OPTIMAL CONVERGENCE RATE OF AN ADAPTIVE DISCONTINUOUS GALERKIN METHOD

QUASI-OPTIMAL CONVERGENCE RATE OF AN ADAPTIVE DISCONTINUOUS GALERKIN METHOD QUASI-OPIMAL CONVERGENCE RAE OF AN ADAPIVE DISCONINUOUS GALERKIN MEHOD ANDREA BONIO AND RICARDO H. NOCHEO Abstract. We analyze an adaptive discontinuous finite element method (ADFEM) for symmetric second

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

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

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

More information

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

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

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

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

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

More information

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

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

More information

Finite Elements. Colin Cotter. January 15, Colin Cotter FEM

Finite Elements. Colin Cotter. January 15, Colin Cotter FEM Finite Elements January 15, 2018 Why Can solve PDEs on complicated domains. Have flexibility to increase order of accuracy and match the numerics to the physics. has an elegant mathematical formulation

More information

A BIVARIATE SPLINE METHOD FOR SECOND ORDER ELLIPTIC EQUATIONS IN NON-DIVERGENCE FORM

A BIVARIATE SPLINE METHOD FOR SECOND ORDER ELLIPTIC EQUATIONS IN NON-DIVERGENCE FORM A BIVARIAE SPLINE MEHOD FOR SECOND ORDER ELLIPIC EQUAIONS IN NON-DIVERGENCE FORM MING-JUN LAI AND CHUNMEI WANG Abstract. A bivariate spline method is developed to numerically solve second order elliptic

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

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

Some Background Material

Some Background Material Chapter 1 Some Background Material In the first chapter, we present a quick review of elementary - but important - material as a way of dipping our toes in the water. This chapter also introduces important

More information

Rate optimal adaptive FEM with inexact solver for strongly monotone operators

Rate optimal adaptive FEM with inexact solver for strongly monotone operators ASC Report No. 19/2016 Rate optimal adaptive FEM with inexact solver for strongly monotone operators G. Gantner, A. Haberl, D. Praetorius, B. Stiftner Institute for Analysis and Scientific Computing Vienna

More information

From Completing the Squares and Orthogonal Projection to Finite Element Methods

From Completing the Squares and Orthogonal Projection to Finite Element Methods From Completing the Squares and Orthogonal Projection to Finite Element Methods Mo MU Background In scientific computing, it is important to start with an appropriate model in order to design effective

More information

NONSTANDARD NONCONFORMING APPROXIMATION OF THE STOKES PROBLEM, I: PERIODIC BOUNDARY CONDITIONS

NONSTANDARD NONCONFORMING APPROXIMATION OF THE STOKES PROBLEM, I: PERIODIC BOUNDARY CONDITIONS NONSTANDARD NONCONFORMING APPROXIMATION OF THE STOKES PROBLEM, I: PERIODIC BOUNDARY CONDITIONS J.-L. GUERMOND 1, Abstract. This paper analyzes a nonstandard form of the Stokes problem where the mass conservation

More information

Maximum norm estimates for energy-corrected finite element method

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

More information

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

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

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

The Mortar Boundary Element Method

The Mortar Boundary Element Method The Mortar Boundary Element Method A Thesis submitted for the degree of Doctor of Philosophy by Martin Healey School of Information Systems, Computing and Mathematics Brunel University March 2010 Abstract

More information

Cover Page. The handle holds various files of this Leiden University dissertation.

Cover Page. The handle   holds various files of this Leiden University dissertation. Cover Page The handle http://hdl.handle.net/1887/20139 holds various files of this Leiden University dissertation. Author: Dahlhaus, Jan Patrick Title: Random-matrix theory and stroboscopic models of topological

More information

Numerische Mathematik

Numerische Mathematik Numer. Math. (2004) 97: 193 217 Digital Object Identifier (DOI) 10.1007/s00211-003-0493-6 Numerische Mathematik Fast computation in adaptive tree approximation Peter Binev, Ronald DeVore Department of

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

Cover Page. The handle holds various files of this Leiden University dissertation.

Cover Page. The handle  holds various files of this Leiden University dissertation. Cover Page The handle http://hdl.handle.net/1887/45233 holds various files of this Leiden University dissertation. Author: Rijk, B. de Title: Periodic pulse solutions to slowly nonlinear reaction-diffusion

More information

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

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

More information

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

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 Balancing Algorithm for Mortar Methods

A Balancing Algorithm for Mortar Methods A Balancing Algorithm for Mortar Methods Dan Stefanica Baruch College, City University of New York, NY 11, USA Dan Stefanica@baruch.cuny.edu Summary. The balancing methods are hybrid nonoverlapping Schwarz

More information

On angle conditions in the finite element method. Institute of Mathematics, Academy of Sciences Prague, Czech Republic

On angle conditions in the finite element method. Institute of Mathematics, Academy of Sciences Prague, Czech Republic On angle conditions in the finite element method Michal Křížek Institute of Mathematics, Academy of Sciences Prague, Czech Republic Joint work with Jan Brandts (University of Amsterdam), Antti Hannukainen

More information

Acceleration of a Domain Decomposition Method for Advection-Diffusion Problems

Acceleration of a Domain Decomposition Method for Advection-Diffusion Problems Acceleration of a Domain Decomposition Method for Advection-Diffusion Problems Gert Lube 1, Tobias Knopp 2, and Gerd Rapin 2 1 University of Göttingen, Institute of Numerical and Applied Mathematics (http://www.num.math.uni-goettingen.de/lube/)

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

Spline Element Method for Partial Differential Equations

Spline Element Method for Partial Differential Equations for Partial Differential Equations Department of Mathematical Sciences Northern Illinois University 2009 Multivariate Splines Summer School, Summer 2009 Outline 1 Why multivariate splines for PDEs? Motivation

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

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

Optimal multilevel preconditioning of strongly anisotropic problems.part II: non-conforming FEM. p. 1/36

Optimal multilevel preconditioning of strongly anisotropic problems.part II: non-conforming FEM. p. 1/36 Optimal multilevel preconditioning of strongly anisotropic problems. Part II: non-conforming FEM. Svetozar Margenov margenov@parallel.bas.bg Institute for Parallel Processing, Bulgarian Academy of Sciences,

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

Singularly Perturbed Partial Differential Equations

Singularly Perturbed Partial Differential Equations WDS'9 Proceedings of Contributed Papers, Part I, 54 59, 29. ISN 978-8-7378--9 MTFYZPRESS Singularly Perturbed Partial Differential Equations J. Lamač Charles University, Faculty of Mathematics and Physics,

More information

JUHA KINNUNEN. Harmonic Analysis

JUHA KINNUNEN. Harmonic Analysis JUHA KINNUNEN Harmonic Analysis Department of Mathematics and Systems Analysis, Aalto University 27 Contents Calderón-Zygmund decomposition. Dyadic subcubes of a cube.........................2 Dyadic cubes

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

Domain decomposition in the Jacobi-Davidson method for eigenproblems

Domain decomposition in the Jacobi-Davidson method for eigenproblems Domain decomposition in the Jacobi-Davidson method for eigenproblems Menno Genseberger Domain decomposition in the Jacobi-Davidson method for eigenproblems Domeindecompositie in de Jacobi-Davidson methode

More information

Lecture Notes: African Institute of Mathematics Senegal, January Topic Title: A short introduction to numerical methods for elliptic PDEs

Lecture Notes: African Institute of Mathematics Senegal, January Topic Title: A short introduction to numerical methods for elliptic PDEs Lecture Notes: African Institute of Mathematics Senegal, January 26 opic itle: A short introduction to numerical methods for elliptic PDEs Authors and Lecturers: Gerard Awanou (University of Illinois-Chicago)

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

Second Order Elliptic PDE

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

More information

Axioms of Adaptivity

Axioms of Adaptivity Axioms of Adaptivity Carsten Carstensen Humboldt-Universität zu Berlin Open-Access Reference: C-Feischl-Page-Praetorius: Axioms of Adaptivity. Computer & Mathematics with Applications 67 (2014) 1195 1253

More information

A Balancing Algorithm for Mortar Methods

A Balancing Algorithm for Mortar Methods A Balancing Algorithm for Mortar Methods Dan Stefanica Baruch College, City University of New York, NY, USA. Dan_Stefanica@baruch.cuny.edu Summary. The balancing methods are hybrid nonoverlapping Schwarz

More information

PREPRINT 2010:23. A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO

PREPRINT 2010:23. A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO PREPRINT 2010:23 A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO Department of Mathematical Sciences Division of Mathematics CHALMERS UNIVERSITY OF TECHNOLOGY UNIVERSITY OF GOTHENBURG

More information

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

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

More information

PDEs, part 1: Introduction and elliptic PDEs

PDEs, part 1: Introduction and elliptic PDEs PDEs, part 1: Introduction and elliptic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2013 Partial di erential equations The solution depends on several variables,

More information

Constrained Minimization and Multigrid

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

More information

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

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

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

More information

Remarks on the analysis of finite element methods on a Shishkin mesh: are Scott-Zhang interpolants applicable?

Remarks on the analysis of finite element methods on a Shishkin mesh: are Scott-Zhang interpolants applicable? Remarks on the analysis of finite element methods on a Shishkin mesh: are Scott-Zhang interpolants applicable? Thomas Apel, Hans-G. Roos 22.7.2008 Abstract In the first part of the paper we discuss minimal

More information

Chapter 1 Foundations of Elliptic Boundary Value Problems 1.1 Euler equations of variational problems

Chapter 1 Foundations of Elliptic Boundary Value Problems 1.1 Euler equations of variational problems Chapter 1 Foundations of Elliptic Boundary Value Problems 1.1 Euler equations of variational problems Elliptic boundary value problems often occur as the Euler equations of variational problems the latter

More information

The Discontinuous Galerkin Finite Element Method

The Discontinuous Galerkin Finite Element Method The Discontinuous Galerkin Finite Element Method Michael A. Saum msaum@math.utk.edu Department of Mathematics University of Tennessee, Knoxville The Discontinuous Galerkin Finite Element Method p.1/41

More information

NUMERICAL SOLUTION OF CONVECTION DIFFUSION EQUATIONS USING UPWINDING TECHNIQUES SATISFYING THE DISCRETE MAXIMUM PRINCIPLE

NUMERICAL SOLUTION OF CONVECTION DIFFUSION EQUATIONS USING UPWINDING TECHNIQUES SATISFYING THE DISCRETE MAXIMUM PRINCIPLE Proceedings of the Czech Japanese Seminar in Applied Mathematics 2005 Kuju Training Center, Oita, Japan, September 15-18, 2005 pp. 69 76 NUMERICAL SOLUTION OF CONVECTION DIFFUSION EQUATIONS USING UPWINDING

More information

WELL POSEDNESS OF PROBLEMS I

WELL POSEDNESS OF PROBLEMS I Finite Element Method 85 WELL POSEDNESS OF PROBLEMS I Consider the following generic problem Lu = f, where L : X Y, u X, f Y and X, Y are two Banach spaces We say that the above problem is well-posed (according

More information

CONVERGENCE THEORY. G. ALLAIRE CMAP, Ecole Polytechnique. 1. Maximum principle. 2. Oscillating test function. 3. Two-scale convergence

CONVERGENCE THEORY. G. ALLAIRE CMAP, Ecole Polytechnique. 1. Maximum principle. 2. Oscillating test function. 3. Two-scale convergence 1 CONVERGENCE THEOR G. ALLAIRE CMAP, Ecole Polytechnique 1. Maximum principle 2. Oscillating test function 3. Two-scale convergence 4. Application to homogenization 5. General theory H-convergence) 6.

More information

Adaptive methods for control problems with finite-dimensional control space

Adaptive methods for control problems with finite-dimensional control space Adaptive methods for control problems with finite-dimensional control space Saheed Akindeinde and Daniel Wachsmuth Johann Radon Institute for Computational and Applied Mathematics (RICAM) Austrian Academy

More information

A Finite Element Method for the Surface Stokes Problem

A Finite Element Method for the Surface Stokes Problem J A N U A R Y 2 0 1 8 P R E P R I N T 4 7 5 A Finite Element Method for the Surface Stokes Problem Maxim A. Olshanskii *, Annalisa Quaini, Arnold Reusken and Vladimir Yushutin Institut für Geometrie und

More information

A DECOMPOSITION RESULT FOR BIHARMONIC PROBLEMS AND THE HELLAN-HERRMANN-JOHNSON METHOD

A DECOMPOSITION RESULT FOR BIHARMONIC PROBLEMS AND THE HELLAN-HERRMANN-JOHNSON METHOD Electronic ransactions on Numerical Analysis. Volume 45, pp. 257 282, 2016. Copyright c 2016,. ISSN 1068 9613. ENA A DECOMPOSIION RESUL FOR BIHARMONIC PROBLEMS AND HE HELLAN-HERRMANN-JOHNSON MEHOD WOLFGANG

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

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Roy Stogner Computational Fluid Dynamics Lab Institute for Computational Engineering and Sciences University of Texas at Austin March

More information

Institut für Mathematik

Institut für Mathematik U n i v e r s i t ä t A u g s b u r g Institut für Mathematik Pedro Morin, Kunibert G. Siebert, Andreas Veeser A Basic Convergence Result for Conforming Adaptive Finite Elements Preprint Nr. 007/2007 22.

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

Numerical Methods for Partial Differential Equations

Numerical Methods for Partial Differential Equations Numerical Methods for Partial Differential Equations Eric de Sturler University of Illinois at Urbana-Champaign Read section 8. to see where equations of type (au x ) x = f show up and their (exact) solution

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 Variational Problems of the Dirichlet BVP of the Poisson Equation 1 For the homogeneous

More information

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

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

More information

Introduction to Real Analysis Alternative Chapter 1

Introduction to Real Analysis Alternative Chapter 1 Christopher Heil Introduction to Real Analysis Alternative Chapter 1 A Primer on Norms and Banach Spaces Last Updated: March 10, 2018 c 2018 by Christopher Heil Chapter 1 A Primer on Norms and Banach Spaces

More information

The Virtual Element Method: an introduction with focus on fluid flows

The Virtual Element Method: an introduction with focus on fluid flows The Virtual Element Method: an introduction with focus on fluid flows L. Beirão da Veiga Dipartimento di Matematica e Applicazioni Università di Milano-Bicocca VEM people (or group representatives): P.

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

A STOKES INTERFACE PROBLEM: STABILITY, FINITE ELEMENT ANALYSIS AND A ROBUST SOLVER

A STOKES INTERFACE PROBLEM: STABILITY, FINITE ELEMENT ANALYSIS AND A ROBUST SOLVER European Congress on Computational Methods in Applied Sciences and Engineering ECCOMAS 2004 P. Neittaanmäki, T. Rossi, K. Majava, and O. Pironneau (eds.) O. Nevanlinna and R. Rannacher (assoc. eds.) Jyväskylä,

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

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

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

Konstantinos Chrysafinos 1 and L. Steven Hou Introduction

Konstantinos Chrysafinos 1 and L. Steven Hou Introduction Mathematical Modelling and Numerical Analysis Modélisation Mathématique et Analyse Numérique Will be set by the publisher ANALYSIS AND APPROXIMATIONS OF THE EVOLUTIONARY STOKES EQUATIONS WITH INHOMOGENEOUS

More information

DISCRETE MAXIMUM PRINCIPLES in THE FINITE ELEMENT SIMULATIONS

DISCRETE MAXIMUM PRINCIPLES in THE FINITE ELEMENT SIMULATIONS DISCRETE MAXIMUM PRINCIPLES in THE FINITE ELEMENT SIMULATIONS Sergey Korotov BCAM Basque Center for Applied Mathematics http://www.bcamath.org 1 The presentation is based on my collaboration with several

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

Analysis of Hybrid Discontinuous Galerkin Methods for Incompressible Flow Problems

Analysis of Hybrid Discontinuous Galerkin Methods for Incompressible Flow Problems Analysis of Hybrid Discontinuous Galerkin Methods for Incompressible Flow Problems Christian Waluga 1 advised by Prof. Herbert Egger 2 Prof. Wolfgang Dahmen 3 1 Aachen Institute for Advanced Study in Computational

More information

FINITE ELEMENT APPROXIMATION OF STOKES-LIKE SYSTEMS WITH IMPLICIT CONSTITUTIVE RELATION

FINITE ELEMENT APPROXIMATION OF STOKES-LIKE SYSTEMS WITH IMPLICIT CONSTITUTIVE RELATION Proceedings of ALGORITMY pp. 9 3 FINITE ELEMENT APPROXIMATION OF STOKES-LIKE SYSTEMS WITH IMPLICIT CONSTITUTIVE RELATION JAN STEBEL Abstract. The paper deals with the numerical simulations of steady flows

More information

l(y j ) = 0 for all y j (1)

l(y j ) = 0 for all y j (1) Problem 1. The closed linear span of a subset {y j } of a normed vector space is defined as the intersection of all closed subspaces containing all y j and thus the smallest such subspace. 1 Show that

More information

arxiv: v1 [math.na] 11 Jul 2011

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

More information

A 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

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

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