Finite Elements

Total Page:16

File Type:pdf, Size:1020Kb

Finite Elements Finite Elements Guido Kanschat May 7, 2019 Contents 1 Elliptic PDE and Their Weak Formulation 3 1.1 Elliptic boundary value problems . .3 1.1.1 Linear second order PDE . .3 1.1.2 Variational principle and weak formulation . .8 1.1.3 Boundary conditions in weak form . 10 1.2 Hilbert Spaces and Bilinear Forms . 11 1.3 Fast Facts on Sobolev Spaces . 20 1.4 Regularity of Weak Solutions . 24 2 Conforming Finite Element Methods 27 2.1 Meshes, shape functions, and degrees of freedom . 27 2.1.1 Shape function spaces on simplices . 30 2.1.2 Shape functions on tensor product cells . 31 2.1.3 The Galerkin equations and Céa’s lemma . 35 2.1.4 Mapped finite elements . 37 2.2 A priori error analysis . 40 2.2.1 Approximation of Sobolev spaces by finite elements . 41 2.2.2 Estimates of stronger norms . 45 2.2.3 Estimates of weaker norms and linear functionals . 46 2.2.4 Green’s function and maximum norm estimates . 48 2.3 A posteriori error analysis . 50 2.3.1 Quasi-interpolation in H1 .................. 50 1 3 Variational Crimes 59 3.1 Numerical quadrature . 59 4 Solving the Discrete Problem 67 4.1 The Richardson iteration . 70 4.2 The conjugate gradient method . 75 4.3 Condition numbers of finite element matrices . 79 4.4 Multigrid methods . 82 5 Discontinuous Galerkin methods 84 5.1 Nitsche’s method . 84 5.2 The interior penalty method . 89 5.2.1 Bounded formulation in H1 ................. 93 2 Chapter 1 Elliptic PDE and Their Weak Formulation 1.1 Elliptic boundary value problems 1.1.1 Linear second order PDE 1.1.1 Notation: Dimension of “physical space” will be denoted by d. We denote coordinates in Rd as T x = (x1; : : : ; xd) : In the special cases d = 2; 3 we also write 0x1 x x = ; x = y ; y @ A z respectively. The Euclidean norm on Rd is denoted as v u d uX 2 jxj = t xi : i=1 3 1.1.2 Notation: Partial derivatives of a function u 2 C1(Rd) are de- noted by @u(x) @ = @x u(x) = @xi u(x) = @iu(x): @xi i The gradient of u 2 C1 is the row vector ru = (@1u; : : : ; @du) The Laplacian of a function u 2 C2(Rd) is d 2 2 X 2 ∆u = @1 u + ··· + @du = @i u i=1 1.1.3 Notation: When we write equations, we typically omit the inde- pendent variable x. Therefore, ∆u ≡ ∆u(x): 1.1.4 Definition: A linear PDE of second order in divergence form for a function u 2 C2(Rd) is an equation of the form d d X X − @i aij(x)@ju + bi(x)@iu + c(x)u = f(x) (1.1) i;j=1 i=1 1.1.5 Definition: An important model problem for the equations we are going to study is Poisson’s equation −∆u = f: (1.2) 1.1.6. Already with ordinary differential equations we experience that we typi- cally do not search for solutions of the equation itself, but that we “anchor” the solution by solving an initial value problem, fixing the solution at one point on the time axis. It does not make sense to speak about an initial point in Rd. Instead, it turns out that it is appropriate to consider solutions on certain subsets of Rd and impose conditions at the boundary. 4 1.1.7 Definition: A domain in Rd is a connected, open set of Rd. We typically use the notation Ω ⊂ Rd. The boundary of a domain Ω is denoted by @Ω. To any point x 2 @Ω, we associate the outer unit normal vector n ≡ n(x). The symbol @nu ≡ (ru)n denotes the normal derivative of a function u 2 C1(Ω) at a point x 2 @Ω. 1.1.8 Definition: We distinguish three types of boundary conditions for Poisson’s equation, namely for a point x 2 @Ω with a given function g 1. Dirichlet: u(x) = g(x) 2. Neumann: @nu(x) = g(x) 3. Robin: for some positive function α on dΩ @nu(x) + α(x)u(x) = g(x) While only one of these boundary conditions can hold in a single point x, different boundary conditions can be active on different subsets of @Ω. We denote such subsets as ΓD, ΓN , and ΓR. 1.1.9 Definition: The Dirichlet problem for Poisson’s equation (in differential form) is: find u 2 C2(Ω) \ C(Ω), such that −∆u(x) = f(x) x 2 Ω; (1.3a) u(x) = g(x) x 2 @Ω: (1.3b) Here, the functions f on Ω and g on @Ω are data of the problem. The Dirichlet problem is called homogeneous, if g ≡ 0. 5 1.1.10 Theorem (Dirichlet principle): If a function u 2 C2(Ω) \ C(Ω) solves the Dirichlet problem, then it minimizes the Dirichlet en- ergy Z Z 1 2 E(v) = 2 jrvj dx − fv dx; (1.4) Ω Ω among all functions v from the set 2 Vg = v 2 C (Ω) \ C(Ω) vj@Ω = g : (1.5) This minimizer is unique. Proof. Using variation of E, we will show that d E(u + "v) = 0 d" "=0 for all v 2 V0 since this implies u + "v = g on @Ω. By evaluating the square we have d Z E(u + "v) = rurv + "jrvj2 − fv dx d" Ω Since we are intersted in E(u), we now consider " = 0. We get that u minimizes E(u + "v) at " = 0 implies Z Z rurv dx = fv dx; 8v 2 V0: Ω Ω By Green’s formula Z Z Z rurv dx = −∆uv dx + @nuv ds Ω Ω @Ω we obtain that if u minimizes E(·), then Z Z rurv dx = fv dx; 8v 2 V0; Ω Ω since v 2 V0 vanishes on @Ω. In summary, we have proven so far that if u solves Poisson’s Equation, then it is a stationary point of E(·). It remains to show R R that E(u) ≤ E(u + v) for any v 2 V0. Using Ω fv dx = Ω rurv yields 1 Z 1 E(u+v)−E(u) = jr(u+v)j2−2r(u+v)ru+jruj2 dx = jrvj2 dx ≥ 0: 2 Ω 2 This also proves uniqueness. 6 1.1.11 Lemma: A minimizing sequence for the Dirichlet energy exists and it is a Cauchy sequence. Proof. The Dirichlet energy E(·) is bounded from below and hence an infinum (n) exists. Thus, there also exists a series fu gn2N converging to this infinum, i.e. lim E(u(n)) = inf E(v): n!1 v2V0 (n) Second, we show that fu gn is a Cauchy sequence. For the first part we use Friedrich’s inequality kvkL2(Ω) ≤ λ(Ω)krvkL2(Ω) v 2 V0: The proof of this result will be given later. Using Hölder’s inequality we obtain Z 1 2 1 2 E(v) = krvkL2(Ω − fv dx ≥ krvkL2(Ω − kfkL2(ΩkvkL2(Ω 2 Ω 2 Applying Friedrich’s inquality yields that the above expression is greater or equal than 1 2 1 krvk 2 − krvk 2 kfk 2 : 2 L (Ω L (Ω λ(Ω) L (Ω 2 2 Finally, we apply Young’s inequality ab ≤ 1=2(a + b ) to obtain 1 2 2 1 2 krvk 2 − krvk 2 − kfk 2 2 L (Ω L (Ω 2λ(Ω) L (Ω 1 2 which yields E(v) ≥ − 2λ(Ω)2 kfkL2(Ω as a lower bound independent of v. To prove the second part, we use the parallelogram identity jv + wj2 + jv − wj2 = 2jvj2 + 2jwj2. Let m; n be natural numbers, then (n) (m) 2 (n) 2 (m) 2 1 (n) (m) 2 ju − u j1 =2ju j1 + 2ju j1 − 4j =2(u + u j1 Z Z =4E(u(n)) + 4 fu(n) dx + 4E(u(m)) + 4 fu(m) dx Z (n) (m) (n) (m) − 8E(1=2(u + u ) − 8 1=2f(u + u ) (n) (m) (n) (m) =4E(u ) + 4E(u ) − 8E(1=2f(u + u )) (n) (m) Taking the limit m; n ! 1 yields 4E(u ) + 4E(u ) ! 8 infv2V0 E(v). 1 (n) (m) Lastly, −E( =2f(u + u )) can be bounded by infv2V0 E(v). It follows that (n) (m) 2 lim supm;n!1ju − u j1 ≤ 0 and consequently as desired (n) (m) 2 lim ju − u j1 = 0: m;n!1 7 Note 1.1.12. Dirichlet-proof Dirichlet’s principle proved essential for the de- velopment of a rigorous solution theory for Poisson’s equation. Its proof will be deferred to the next theorem. 1.1.2 Variational principle and weak formulation 1.1.13 Theorem: A function u 2 Vg minimizes the Dirichlet energy, if and only if there holds Z Z ru · rv dx = fv dx; 8v 2 V0: (1.6) Ω Ω Moreover, any solution to the Dirichlet problem in Definition 1.1.9 solves this equation. 1.1.14 Corollary: If a minimizer of the Dirichlet energy exists, it is necessarily unique. 1.1.15 Lemma: A function u 2 Vg minimizes the Dirichlet energy admits the representation u = ug + u0, where ug 2 Vg is arbitrary and u0 2 V0 solves Z Z Z ru · rv dx = fv dx − rug · rv dx; 8v 2 V0: (1.7) Ω Ω Ω The function u0 depends on the choice of ug, but not the minimizer u. 1.1.16 Notation: The inner product of L2(Ω) is denoted by Z (u; v) ≡ (u; v)Ω ≡ (u; v)L2(Ω) = uv dx: Ω Its norm is q kuk ≡ kukΩ ≡ kukL2(Ω) ≡ kukL2 = (u; v)L2(Ω): 1.1.17 Lemma (Friedrichs inequality): For any function in v 2 V0 there holds kvkΩ ≤ diam(Ω)krvkΩ: (1.8) 8 1.1.18 Lemma: The definitions jvj1 = krvkL2(Ω); (1.9) q 2 2 kvk1 = kvkL2(Ω) + jvj1; both define a norm on V0.
Recommended publications
  • Elliptic Pdes
    viii CHAPTER 4 Elliptic PDEs One of the main advantages of extending the class of solutions of a PDE from classical solutions with continuous derivatives to weak solutions with weak deriva- tives is that it is easier to prove the existence of weak solutions. Having estab- lished the existence of weak solutions, one may then study their properties, such as uniqueness and regularity, and perhaps prove under appropriate assumptions that the weak solutions are, in fact, classical solutions. There is often considerable freedom in how one defines a weak solution of a PDE; for example, the function space to which a solution is required to belong is not given a priori by the PDE itself. Typically, we look for a weak formulation that reduces to the classical formulation under appropriate smoothness assumptions and which is amenable to a mathematical analysis; the notion of solution and the spaces to which solutions belong are dictated by the available estimates and analysis. 4.1. Weak formulation of the Dirichlet problem Let us consider the Dirichlet problem for the Laplacian with homogeneous boundary conditions on a bounded domain Ω in Rn, (4.1) −∆u = f in Ω, (4.2) u =0 on ∂Ω. First, suppose that the boundary of Ω is smooth and u,f : Ω → R are smooth functions. Multiplying (4.1) by a test function φ, integrating the result over Ω, and using the divergence theorem, we get ∞ (4.3) Du · Dφ dx = fφ dx for all φ ∈ Cc (Ω). ZΩ ZΩ The boundary terms vanish because φ = 0 on the boundary.
    [Show full text]
  • Elliptic Pdes
    CHAPTER 4 Elliptic PDEs One of the main advantages of extending the class of solutions of a PDE from classical solutions with continuous derivatives to weak solutions with weak deriva- tives is that it is easier to prove the existence of weak solutions. Having estab- lished the existence of weak solutions, one may then study their properties, such as uniqueness and regularity, and perhaps prove under appropriate assumptions that the weak solutions are, in fact, classical solutions. There is often considerable freedom in how one defines a weak solution of a PDE; for example, the function space to which a solution is required to belong is not given a priori by the PDE itself. Typically, we look for a weak formulation that reduces to the classical formulation under appropriate smoothness assumptions and which is amenable to a mathematical analysis; the notion of solution and the spaces to which solutions belong are dictated by the available estimates and analysis. 4.1. Weak formulation of the Dirichlet problem Let us consider the Dirichlet problem for the Laplacian with homogeneous boundary conditions on a bounded domain Ω in Rn, (4.1) −∆u = f in Ω; (4.2) u = 0 on @Ω: First, suppose that the boundary of Ω is smooth and u; f : Ω ! R are smooth functions. Multiplying (4.1) by a test function φ, integrating the result over Ω, and using the divergence theorem, we get Z Z 1 (4.3) Du · Dφ dx = fφ dx for all φ 2 Cc (Ω): Ω Ω The boundary terms vanish because φ = 0 on the boundary.
    [Show full text]
  • Baire Category Theorem and Uniform Boundedness Principle)
    Functional Analysis (WS 19/20), Problem Set 3 (Baire Category Theorem and Uniform Boundedness Principle) Baire Category Theorem B1. Let (X; k·kX ) be an innite dimensional Banach space. Prove that X has uncountable Hamel basis. Note: This is Problem A2 from Problem Set 1. B2. Consider subset of bounded sequences 1 A = fx 2 l : only nitely many xk are nonzerog : Can one dene a norm on A so that it becomes a Banach space? Consider the same question with the set of polynomials dened on interval [0; 1]. B3. Prove that the set L2(0; 1) has empty interior as the subset of Banach space L1(0; 1). B4. Let f : [0; 1) ! [0; 1) be a continuous function such that for every x 2 [0; 1), f(kx) ! 0 as k ! 1. Prove that f(x) ! 0 as x ! 1. B5.( Uniform Boundedness Principle) Let (X; k · kX ) be a Banach space and (Y; k · kY ) be a normed space. Let fTαgα2A be a family of bounded linear operators between X and Y . Suppose that for any x 2 X, sup kTαxkY < 1: α2A Prove that . supα2A kTαk < 1 Uniform Boundedness Principle U1. Let F be a normed space C[0; 1] with L2(0; 1) norm. Check that the formula 1 Z n 'n(f) = n f(t) dt 0 denes a bounded linear functional on . Verify that for every , F f 2 F supn2N j'n(f)j < 1 but . Why Uniform Boundedness Principle is not satised in this case? supn2N k'nk = 1 U2.( pointwise convergence of operators) Let (X; k · kX ) be a Banach space and (Y; k · kY ) be a normed space.
    [Show full text]
  • 3 Bilinear Forms & Euclidean/Hermitian Spaces
    3 Bilinear Forms & Euclidean/Hermitian Spaces Bilinear forms are a natural generalisation of linear forms and appear in many areas of mathematics. Just as linear algebra can be considered as the study of `degree one' mathematics, bilinear forms arise when we are considering `degree two' (or quadratic) mathematics. For example, an inner product is an example of a bilinear form and it is through inner products that we define the notion of length in n p 2 2 analytic geometry - recall that the length of a vector x 2 R is defined to be x1 + ... + xn and that this formula holds as a consequence of Pythagoras' Theorem. In addition, the `Hessian' matrix that is introduced in multivariable calculus can be considered as defining a bilinear form on tangent spaces and allows us to give well-defined notions of length and angle in tangent spaces to geometric objects. Through considering the properties of this bilinear form we are able to deduce geometric information - for example, the local nature of critical points of a geometric surface. In this final chapter we will give an introduction to arbitrary bilinear forms on K-vector spaces and then specialise to the case K 2 fR, Cg. By restricting our attention to thse number fields we can deduce some particularly nice classification theorems. We will also give an introduction to Euclidean spaces: these are R-vector spaces that are equipped with an inner product and for which we can `do Euclidean geometry', that is, all of the geometric Theorems of Euclid will hold true in any arbitrary Euclidean space.
    [Show full text]
  • Representation of Bilinear Forms in Non-Archimedean Hilbert Space by Linear Operators
    Comment.Math.Univ.Carolin. 47,4 (2006)695–705 695 Representation of bilinear forms in non-Archimedean Hilbert space by linear operators Toka Diagana This paper is dedicated to the memory of Tosio Kato. Abstract. The paper considers representing symmetric, non-degenerate, bilinear forms on some non-Archimedean Hilbert spaces by linear operators. Namely, upon making some assumptions it will be shown that if φ is a symmetric, non-degenerate bilinear form on a non-Archimedean Hilbert space, then φ is representable by a unique self-adjoint (possibly unbounded) operator A. Keywords: non-Archimedean Hilbert space, non-Archimedean bilinear form, unbounded operator, unbounded bilinear form, bounded bilinear form, self-adjoint operator Classification: 47S10, 46S10 1. Introduction Representing bounded or unbounded, symmetric, bilinear forms by linear op- erators is among the most attractive topics in representation theory due to its significance and its possible applications. Applications include those arising in quantum mechanics through the study of the form sum associated with the Hamil- tonians, mathematical physics, symplectic geometry, variational methods through the study of weak solutions to some partial differential equations, and many oth- ers, see, e.g., [3], [7], [10], [11]. This paper considers representing symmetric, non- degenerate, bilinear forms defined over the so-called non-Archimedean Hilbert spaces Eω by linear operators as it had been done for closed, positive, symmetric, bilinear forms in the classical setting, see, e.g., Kato [11, Chapter VI, Theo- rem 2.23, p. 331]. Namely, upon making some assumptions it will be shown that if φ : D(φ) × D(φ) ⊂ Eω × Eω 7→ K (K being the ground field) is a symmetric, non-degenerate, bilinear form, then there exists a unique self-adjoint (possibly unbounded) operator A such that (1.1) φ(u, v)= hAu, vi, ∀ u ∈ D(A), v ∈ D(φ) where D(A) and D(φ) denote the domains of A and φ, respectively.
    [Show full text]
  • Advanced Partial Differential Equations Prof. Dr. Thomas
    Advanced Partial Differential Equations Prof. Dr. Thomas Sørensen summer term 2015 Marcel Schaub July 2, 2015 1 Contents 0 Recall PDE 1 & Motivation 3 0.1 Recall PDE 1 . .3 1 Weak derivatives and Sobolev spaces 7 1.1 Sobolev spaces . .8 1.2 Approximation by smooth functions . 11 1.3 Extension of Sobolev functions . 13 1.4 Traces . 15 1.5 Sobolev inequalities . 17 2 Linear 2nd order elliptic PDE 25 2.1 Linear 2nd order elliptic partial differential operators . 25 2.2 Weak solutions . 26 2.3 Existence via Lax-Milgram . 28 2.4 Inhomogeneous bounday value problems . 35 2.5 The space H−1(U) ................................ 36 2.6 Regularity of weak solutions . 39 A Tutorials 58 A.1 Tutorial 1: Review of Integration . 58 A.2 Tutorial 2 . 59 A.3 Tutorial 3: Norms . 61 A.4 Tutorial 4 . 62 A.5 Tutorial 6 (Sheet 7) . 65 A.6 Tutorial 7 . 65 A.7 Tutorial 9 . 67 A.8 Tutorium 11 . 67 B Solutions of the problem sheets 70 B.1 Solution to Sheet 1 . 70 B.2 Solution to Sheet 2 . 71 B.3 Solution to Problem Sheet 3 . 73 B.4 Solution to Problem Sheet 4 . 76 B.5 Solution to Exercise Sheet 5 . 77 B.6 Solution to Exercise Sheet 7 . 81 B.7 Solution to problem sheet 8 . 84 B.8 Solution to Exercise Sheet 9 . 87 2 0 Recall PDE 1 & Motivation 0.1 Recall PDE 1 We mainly studied linear 2nd order equations – specifically, elliptic, parabolic and hyper- bolic equations. Concretely: • The Laplace equation ∆u = 0 (elliptic) • The Poisson equation −∆u = f (elliptic) • The Heat equation ut − ∆u = 0, ut − ∆u = f (parabolic) • The Wave equation utt − ∆u = 0, utt − ∆u = f (hyperbolic) We studied (“main motivation; goal”) well-posedness (à la Hadamard) 1.
    [Show full text]
  • A Symplectic Banach Space with No Lagrangian Subspaces
    transactions of the american mathematical society Volume 273, Number 1, September 1982 A SYMPLECTIC BANACHSPACE WITH NO LAGRANGIANSUBSPACES BY N. J. KALTON1 AND R. C. SWANSON Abstract. In this paper we construct a symplectic Banach space (X, Ü) which does not split as a direct sum of closed isotropic subspaces. Thus, the question of whether every symplectic Banach space is isomorphic to one of the canonical form Y X Y* is settled in the negative. The proof also shows that £(A") admits a nontrivial continuous homomorphism into £(//) where H is a Hilbert space. 1. Introduction. Given a Banach space E, a linear symplectic form on F is a continuous bilinear map ß: E X E -> R which is alternating and nondegenerate in the (strong) sense that the induced map ß: E — E* given by Û(e)(f) = ü(e, f) is an isomorphism of E onto E*. A Banach space with such a form is called a symplectic Banach space. It can be shown, by essentially the argument of Lemma 2 below, that any symplectic Banach space can be renormed so that ß is an isometry. Any symplectic Banach space is reflexive. Standard examples of symplectic Banach spaces all arise in the following way. Let F be a reflexive Banach space and set E — Y © Y*. Define the linear symplectic form fiyby Qy[(^. y% (z>z*)] = z*(y) ~y*(z)- We define two symplectic spaces (£,, ß,) and (E2, ß2) to be equivalent if there is an isomorphism A : Ex -» E2 such that Q2(Ax, Ay) = ß,(x, y). A. Weinstein [10] has asked the question whether every symplectic Banach space is equivalent to one of the form (Y © Y*, üy).
    [Show full text]
  • Properties of Bilinear Forms on Hilbert Spaces Related to Stability Properties of Certain Partial Differential Operators
    JOURNAL OF hlATHEhlATICAL ANALYSIS AND APPLICATIONS 20, 124-144 (1967) Properties of Bilinear Forms on Hilbert Spaces Related to Stability Properties of Certain Partial Differential Operators N. SAUER National Research Institute for Mathematical Sciences, Pretoria, South Africa Submitted by P. Lax INTRODUCTION The continuous dependence of solutions of positive definite, self-adjoint partial differential equations on the domain was investigated by Babugka [I], [2]. In a recent paper, [3], Babugka and Vjibornjr also studied the continuous dependence of the eigenvalues of strongly-elliptic, self-adjoint partial dif- ferential operators on the domain. It is the aim of this paper to study formalisms in abstract Hilbert space by means of which results on various types of continuous dependences can be obtained. In the case of the positive definite operator it is found that the condition of self-adjointness can be dropped. The properties of operators of this type are studied in part II. In part III the behavior of the eigenvalues of a self- adjoint elliptic operator under various “small changes” is studied. In part IV some applications to partial differential operators and variational theory are sketched. I. BASIC: CONCEPTS AND RESULTS Let H be a complex Hilbert space. We use the symbols X, y, z,... for vectors in H and the symbols a, b, c,... for scalars. The inner product in H is denoted by (~,y) and the norm by I( .v 11 = (x, x)llz. Weak and strong convergence of a sequence (x~} to an element x0 E H are denoted by x’, - x0 and x’, + x,, , respectively. A functional f on H is called: (i) continuous if it is continuous in the strong topology on H, (ii) weakly continuous (w.-continuous) if it is continuous in the weak topology on H.
    [Show full text]
  • Fact Sheet Functional Analysis
    Fact Sheet Functional Analysis Literature: Hackbusch, W.: Theorie und Numerik elliptischer Differentialgleichungen. Teubner, 1986. Knabner, P., Angermann, L.: Numerik partieller Differentialgleichungen. Springer, 2000. Triebel, H.: H¨ohere Analysis. Harri Deutsch, 1980. Dobrowolski, M.: Angewandte Funktionalanalysis, Springer, 2010. 1. Banach- and Hilbert spaces Let V be a real vector space. Normed space: A norm is a mapping k · k : V ! [0; 1), such that: kuk = 0 , u = 0; (definiteness) kαuk = jαj · kuk; α 2 R; u 2 V; (positive scalability) ku + vk ≤ kuk + kvk; u; v 2 V: (triangle inequality) The pairing (V; k · k) is called a normed space. Seminorm: In contrast to a norm there may be elements u 6= 0 such that kuk = 0. It still holds kuk = 0 if u = 0. Comparison of two norms: Two norms k · k1, k · k2 are called equivalent if there is a constant C such that: −1 C kuk1 ≤ kuk2 ≤ Ckuk1; u 2 V: If only one of these inequalities can be fulfilled, e.g. kuk2 ≤ Ckuk1; u 2 V; the norm k · k1 is called stronger than the norm k · k2. k · k2 is called weaker than k · k1. Topology: In every normed space a canonical topology can be defined. A subset U ⊂ V is called open if for every u 2 U there exists a " > 0 such that B"(u) = fv 2 V : ku − vk < "g ⊂ U: Convergence: A sequence vn converges to v w.r.t. the norm k · k if lim kvn − vk = 0: n!1 1 A sequence vn ⊂ V is called Cauchy sequence, if supfkvn − vmk : n; m ≥ kg ! 0 for k ! 1.
    [Show full text]
  • BELTRAMI FLOWS a Thesis Submitted to the Kent State University Honors
    BELTRAMI FLOWS Athesissubmittedtothe Kent State University Honors College in partial fulfillment of the requirements for Departmental Honors by Alexander Margetis May, 2018 Thesis written by Alexander Margetis Approved by , Advisor , Chair, Department of Mathematics Accepted by , Dean, Honors College ii Table of Contents Acknowledgments.................................. iv 1 Introduction .................................. 1 2 Sobolev-Spaces & the Lax-Milgram theorem ............. 2 2.0.1 HilbertspaceandtheLax-Milgramtheorem . 3 2.0.2 Dirichlet Problem . 5 2.0.3 NeumannProblem ........................ 8 3 Constructing a solution of (1.1) ...................... 11 3.1 The bilinear form . 12 3.2 A solution of (3.3) results in a solution of (3.1) . 16 References . 19 iii Acknowledgments I would like to thank my research advisor, Dr. Benjamin Jaye for everything he has done. His support and advice in this thesis and everything else has been invaluable. I would also like to thank everyone on my defense committee. I know you did not have to take that time out of your busy schedule. iv Chapter 1 Introduction ABeltramiflowinthree-dimensionalspaceisanincompressible(divergencefree) vector field that is everywhere parallel to its curl. That is, B = curl(B)= r⇥ λB for some function λ.Theseflowsarisenaturallyinmanyphysicalproblems. In astrophysics and in plasma fusion Beltrami fields are known as force-free fields. They describe the equilibrium of perfectly conducting pressure-less plasma in the presence of a strong magnetic field. In fluid mechanics, Beltrami flows arise as steady states of the 3D Euler equations. Numerical evidence suggests that in certain regimes turbulent flows organize into a coherent hierarchy of weakly interacting superimposed approximate Beltrami flows [PYOSL]. Given the importance of Beltrami fields, there are several approaches to proving existence of solutions, for instance use the calculus of variations [LA], and use fixed point arguments [BA].
    [Show full text]
  • Lecture Notes on Mathematical Theory of Finite Elements
    Leszek F. Demkowicz MATHEMATICAL THEORY OF FINITE ELEMENTS Oden Institute for Computational Engineering and Sciences The University of Texas at Austin Austin, TX. May 2020 Preface This monograph is based on my personal lecture notes for the graduate course on Mathematical Theory of Finite Elements (EM394H) that I have been teaching at ICES (now the Oden Institute), at the University of Texas at Austin, in the years 2005-2019. The class has been offered in two versions. The first version is devoted to a study of the energy spaces corresponding to the exact grad-curl-div sequence. The class is rather involved mathematically, and I taught it only every 3-4 years, see [27] for the corresponding lecture notes. The second, more popular version is covered in the presented notes. The primal focus of my lectures has been on the concept of discrete stability and variational problems set up in the energy spaces forming the exact sequence: H1-, H(curl)-, H(div)-, and L2-spaces. From the ap- plication point of view, discussions are wrapped around the classical model problems: diffusion-convection- reaction, elasticity (static and dynamic), linear acoustics, and Maxwell equations. I do not cover transient problems, i.e., all discussed wave propagation problems are formulated in the frequency domain. In the exposition, I follow the historical path and my own personal path of learning the theory. We start with coer- cive problems for which the stability can be taken for granted, and the convergence analysis reduces to the interpolation error estimation. I cover H1−;H(curl)−;H(div)−, and L2-conforming finite elements and construct commuting interpolation operators.
    [Show full text]
  • A Information Can Be Either Provided by a Measurement Or Derived from Theory
    Advanced numerical methods for Inverse problems in evolutionary PDEs Michal Galba supervisor: Marián Slodi£ka Thesis submitted to Ghent University in candidature for the academic degree of Doctor of Philosophy in Mathematics Ghent University Faculty of Engineering and Architecture Academic year Department of Mathematical Analysis 2016-2017 Research Group for Numerical Analysis and Mathematical Modelling (NaM 2) Mathematics knows no races or geographic boundaries; for mathematics, the cultural world is one country. David Hilbert Acknowledgements This dissertation is the result of my research activities that I have concluded within the past four years under the supervision of Professor Marián Slodička, to whom I would like to express my immense gratitude. He has always shared his knowledge with me and oered his helping hand even if the problems I struggled with were of non-mathematical nature. At the same time, I would like to thank my previous teachers, especially to Professor Jozef Kačur and Mgr. Dagmar Krajčiová, whose passion for numbers taught me to love the beauty of mathematics. My research has been supported by Belgian Science Policy project IAP P7/02. I intend to express my appreciation for the essential nancial support. I am also very grateful for the exceptional people I have met. Among them Jaroslav Chovan and Katarína Šišková, who have always been the best friends and colleagues, Karel Van Bockstal who thoroughly read my dissertation and friendly suggested some modications, and Vladimír Vrábeľ who helped me to nd a way when I was lost, especially during my rst year at Ghent University. I am obliged to my family for all that they have done for me.
    [Show full text]