ME280A Introduction to the Finite Element Method

Total Page:16

File Type:pdf, Size:1020Kb

ME280A Introduction to the Finite Element Method ME280A Introduction to the Finite Element Method Panayiotis Papadopoulos Department of Mechanical Engineering University of California, Berkeley 2015 edition Copyright c 2015 by Panayiotis Papadopoulos Contents 1 Introduction to the Finite Element Method 1 1.1 Historical perspective: the origins of the finite element method . ....... 1 1.2 Introductory remarks on the concept of discretization . ........ 3 1.2.1 Structural analogue substitution method . 4 1.2.2 Finite difference method . 5 1.2.3 Finite element method . 6 1.2.4 Particle methods . 8 1.3 Classifications of partial differential equations . .... 9 1.4 Suggestionsforfurtherreading. ... 11 2 Mathematical Preliminaries 13 2.1 Sets, linear function spaces, operators and functionals . ........ 13 2.2 Continuity and differentiability . 17 2.3 Norms, inner products, and completeness . .... 18 2.3.1 Norms................................... 18 2.3.2 Innerproducts .............................. 21 2.3.3 BanachandHilbertspaces . 23 2.3.4 Linear operators and bilinear forms in Hilbert spaces . 25 2.4 Background on variational calculus . 28 2.5 Exercises...................................... 32 2.6 Suggestionsforfurtherreading. ... 34 3 Methods of Weighted Residuals 37 3.1 Introduction.................................... 37 3.2 Galerkinmethods................................. 40 3.3 Collocationmethods ............................... 48 i 3.3.1 Point-collocation method . 49 3.3.2 Subdomain-collocation method . 52 3.4 Least-squaresmethods . .. .. 54 3.5 Compositemethods................................ 57 3.6 An interpretation of finite difference methods . ... 58 3.7 Exercises...................................... 62 3.8 Suggestionsforfurtherreading. ... 69 4 Variational Methods 71 4.1 Introduction to variational principles . .. 71 4.2 Variational forms and variational principles . ... 75 4.3 Rayleigh-Ritzmethod .............................. 77 4.4 Exercises...................................... 81 4.5 Suggestionsforfurtherreading. ... 84 5 Construction of Finite Element Subspaces 87 5.1 Introduction.................................... 87 5.2 Finiteelementspaces............................... 93 5.3 Completenessproperty .............................. 97 5.4 Basic finite element shapes in one, two and three dimensions . .... 101 5.4.1 One dimension . 101 5.4.2 Two dimensions . 101 5.4.3 Three dimensions . 102 5.4.4 Higher dimensions . 102 5.5 Polynomial element interpolation functions . .. 102 5.5.1 Interpolations in one dimension . 102 5.5.2 Interpolations in two dimensions . 108 5.5.3 Interpolations in three dimensions . 120 5.6 Theconceptofisoparametricmapping . 124 5.7 Exercises...................................... 133 6 Computer Implementation of Finite Element Methods 137 6.1 Numerical integration of element matrices . .. 137 6.2 Assemblyofglobalelementarrays. 142 6.3 Algebraic equation solving in finite element methods . 147 ii 6.4 Finite element modeling: mesh design and generation . .. 149 6.4.1 Symmetry................................. 150 6.4.2 Optimal node numbering . 151 6.5 Computerprogramorganization . 152 6.6 Suggestionsforfurtherreading. ... 153 6.7 Exercises...................................... 153 7 Elliptic Differential Equations 157 7.1 The Laplace equation in two dimensions . 157 7.2 Linearelastostatics ................................ 157 7.2.1 A Galerkin approximation to the weak form . 163 7.2.2 On the order of numerical integration . 166 7.2.3 Thepatchtest .............................. 171 7.3 Best approximation property of the finite element method . ..... 174 7.4 Errorsourcesandestimates . 177 7.5 Application to incompressible elastostatics and Stokes’ flow . ...... 180 7.6 Suggestionsforfurtherreading. ... 186 7.7 Exercises...................................... 187 8 Parabolic Differential Equations 191 8.1 Standard semi-discretization methods . ... 192 8.2 Stability of classical time integrators . 199 8.3 Weighted-residual interpretation of classical time integrators ......... 203 8.4 Exercises...................................... 205 9 Hyperbolic Differential Equations 207 9.1 The one-dimensional convection-diffusion equation . ..... 207 9.2 Linearelastodynamics .............................. 213 9.3 Exercises...................................... 219 iii iv List of Figures 1.1 B.G. Galerkin . 1 1.2 R.Courant .................................... 2 1.3 R.W. Clough (left) and J. Argyris (right) . 2 1.4 An infinite degree-of-freedom system ....................... 3 1.5 A simple example of the structural analogue method .............. 4 1.6 The finite difference method in one dimension ................. 5 1.7 A one-dimensional finite element approximation ................ 6 1.8 A one-dimensional kernel function Wl associated with a particle method ... 8 2.1 Schematic depiction of a set .......................... 14 V 2.2 Example of a set that does not form a linear space ............... 15 2.3 Mapping between two sets ............................ 16 2.4 A function of class C0(0, 2) ........................... 18 2.5 Distance between two points in the classical Euclidean sense ......... 19 2.6 The neighborhood (u) of a point u in ................... 20 Nr V 2.7 A continuous piecewise linear function and its derivatives . .... 25 2.8 A linear operator mapping to ........................ 26 U V 2.9 A bilinear form on ............................ 27 U×V 2.10 A functional exhibiting a minimum, maximum or saddle point at u = u∗ ... 28 3.1 An open and connected domain Ω with smooth boundary written as the union of boundary regions ∂Ωi ............................. 37 3.2 The domain Ω of the Laplace-Poisson equation with Dirichlet boundary Γu and Neumann boundary Γq ............................ 40 3.3 Linear and quadratic approximations of the solution to the boundary-value problem in Example 3.2.1 ............................ 47 3.4 The point-collocation method ........................... 49 v 3.5 The point collocation method in a square domain ................ 50 3.6 The subdomain-collocation method ........................ 53 3.7 Polynomial interpolation functions used for region (x ∆x , x + ∆x ] in the l − 2 l 2 weighted-residual interpretation of the finite difference method ........ 59 ∆x 3.8 Polynomial interpolation functions used for region [0, x1 + 2 ] in the weighted- residual interpretation of the finite difference method ............. 59 3.9 Interpolation functions for a finite element approximation of a one-dimensional two-cell domain .................................. 61 4.1 Piecewise linear interpolations functions in one dimension .......... 79 4.2 Comparison of exact and approximate solutions ................ 80 5.1 Geometric interpretation of Fourier coefficients ................ 92 5.2 A finite element mesh ............................... 94 5.3 A finite element-based interpolation function .................. 95 5.4 Finite element vs. exact domain ......................... 96 5.5 Error in the enforcement of Dirichlet boundary conditions due to the difference between the exact and the finite element domain ................ 96 5.6 A potential violation of the integrability (compatibility) requirement ..... 97 5.7 A function u and its approximation uh in the domain (¯x, x¯ + h)....... 98 5.8 Pascal triangle ................................... 100 5.9 Finite element domains in one dimension .................... 101 5.10 Finite element domains in two dimensions ................... 101 5.11 Finite element domains in three dimensions .................. 102 5.12 Linear element interpolation in one dimension ................. 103 5.13 One-dimensional finite element mesh with piecewise linear interpolation ... 103 5.14 Standard quadratic element interpolations in one dimension .......... 104 5.15 Hierarchical quadratic element interpolations in one dimension ........ 105 5.16 Hermitian interpolation functions in one dimension .............. 107 5.17 A 3-node triangular element ........................... 109 5.18 Higher-order triangular elements (left: 6-node element, right: 10-node element)110 5.19 A transitional 4-node triangular element .................... 111 5.20 Area coordinates in a triangular domain .................... 112 5.21 Four-node rectangular element .......................... 113 e 5.22 Interpolation function N1 for a = b =1 (a hyperbolic paraboloid) ....... 114 vi 5.23 Three members of the serendipity family of rectangular elements ....... 114 5.24 Pascal’s triangle for two-dimensional serendipity elements (before accounting for any interior nodes) .............................. 115 5.25 Three members of the Lagrangian family of rectangular elements ....... 115 5.26 Pascal’s triangle for two-dimensional Lagrangian elements .......... 116 5.27 A general quadrilateral finite element domain .................. 117 5.28 Rectangular finite elements made of two or four joined triangular elements . 117 ∂u ∂u 5.29 A simple potential 3- or 4-node triangular element for the case p =2 (u, , ∂s ∂n dofs at nodes 1, 2, 3 and, possibly, u dof at node 4) ............... 118 5.30 Illustration of violation of the integrability requirement for the 9- or 10-dof triangle for the case p =2 ............................ 118 ∂u ∂u 5.31 A 12-dof triangular element for the case p =2 (u, , dofs at nodes 1, 2, 3 ∂s ∂n ∂u and at nodes 4, 5, 6) ............................. 119 ∂n ∂u ∂u 5.32 Clough-Tocher triangular element for the case p =2 (u, , dofs at nodes ∂s ∂n ∂u 1, 2, 3 and at nodes 4, 5, 6) .......................... 120 ∂n 5.33 The 4-node tetrahedral element .........................
Recommended publications
  • Finite Difference Methods for Solving Differential
    FINITE DIFFERENCE METHODS FOR SOLVING DIFFERENTIAL EQUATIONS I-Liang Chern Department of Mathematics National Taiwan University May 16, 2013 2 Contents 1 Introduction 3 1.1 Finite Difference Approximation . ........ 3 1.2 Basic Numerical Methods for Ordinary Differential Equations ........... 5 1.3 Runge-Kuttamethods..... ..... ...... ..... ...... ... ... 8 1.4 Multistepmethods ................................ 10 1.5 Linear difference equation . ...... 14 1.6 Stabilityanalysis ............................... 17 1.6.1 ZeroStability................................. 18 2 Finite Difference Methods for Linear Parabolic Equations 23 2.1 Finite Difference Methods for the Heat Equation . ........... 23 2.1.1 Some discretization methods . 23 2.1.2 Stability and Convergence for the Forward Euler method.......... 25 2.2 L2 Stability – von Neumann Analysis . 26 2.3 Energymethod .................................... 28 2.4 Stability Analysis for Montone Operators– Entropy Estimates ........... 29 2.5 Entropy estimate for backward Euler method . ......... 30 2.6 ExistenceTheory ................................. 32 2.6.1 Existence via forward Euler method . ..... 32 2.6.2 A Sharper Energy Estimate for backward Euler method . ......... 33 2.7 Relaxationoferrors.............................. 34 2.8 BoundaryConditions ..... ..... ...... ..... ...... ... 36 2.8.1 Dirichlet boundary condition . ..... 36 2.8.2 Neumann boundary condition . 37 2.9 The discrete Laplacian and its inversion . .......... 38 2.9.1 Dirichlet boundary condition . ..... 38 3 Finite Difference Methods for Linear elliptic Equations 41 3.1 Discrete Laplacian in two dimensions . ........ 41 3.1.1 Discretization methods . 41 3.1.2 The 9-point discrete Laplacian . ..... 42 3.2 Stability of the discrete Laplacian . ......... 43 3 4 CONTENTS 3.2.1 Fouriermethod ................................ 43 3.2.2 Energymethod ................................ 44 4 Finite Difference Theory For Linear Hyperbolic Equations 47 4.1 A review of smooth theory of linear hyperbolic equations .............
    [Show full text]
  • Exercises from Finite Difference Methods for Ordinary and Partial
    Exercises from Finite Difference Methods for Ordinary and Partial Differential Equations by Randall J. LeVeque SIAM, Philadelphia, 2007 http://www.amath.washington.edu/ rjl/fdmbook ∼ Under construction | more to appear. Contents Chapter 1 4 Exercise 1.1 (derivation of finite difference formula) . 4 Exercise 1.2 (use of fdstencil) . 4 Chapter 2 5 Exercise 2.1 (inverse matrix and Green's functions) . 5 Exercise 2.2 (Green's function with Neumann boundary conditions) . 5 Exercise 2.3 (solvability condition for Neumann problem) . 5 Exercise 2.4 (boundary conditions in bvp codes) . 5 Exercise 2.5 (accuracy on nonuniform grids) . 6 Exercise 2.6 (ill-posed boundary value problem) . 6 Exercise 2.7 (nonlinear pendulum) . 7 Chapter 3 8 Exercise 3.1 (code for Poisson problem) . 8 Exercise 3.2 (9-point Laplacian) . 8 Chapter 4 9 Exercise 4.1 (Convergence of SOR) . 9 Exercise 4.2 (Forward vs. backward Gauss-Seidel) . 9 Chapter 5 11 Exercise 5.1 (Uniqueness for an ODE) . 11 Exercise 5.2 (Lipschitz constant for an ODE) . 11 Exercise 5.3 (Lipschitz constant for a system of ODEs) . 11 Exercise 5.4 (Duhamel's principle) . 11 Exercise 5.5 (matrix exponential form of solution) . 11 Exercise 5.6 (matrix exponential form of solution) . 12 Exercise 5.7 (matrix exponential for a defective matrix) . 12 Exercise 5.8 (Use of ode113 and ode45) . 12 Exercise 5.9 (truncation errors) . 13 Exercise 5.10 (Derivation of Adams-Moulton) . 13 Exercise 5.11 (Characteristic polynomials) . 14 Exercise 5.12 (predictor-corrector methods) . 14 Exercise 5.13 (Order of accuracy of Runge-Kutta methods) .
    [Show full text]
  • Hp-Finite Element Methods for Hyperbolic Problems
    ¢¢¢¢¢¢¢¢¢¢¢ ¢¢¢¢¢¢¢¢¢¢¢ ¢¢¢¢¢¢¢¢¢¢¢ ¢¢¢¢¢¢¢¢¢¢¢ Eidgen¨ossische Ecole polytechnique f´ed´erale de Zurich ¢¢¢¢¢¢¢¢¢¢¢ ¢¢¢¢¢¢¢¢¢¢¢ ¢¢¢¢¢¢¢¢¢¢¢ ¢¢¢¢¢¢¢¢¢¢¢ Technische Hochschule Politecnico federale di Zurigo ¢¢¢¢¢¢¢¢¢¢¢ ¢¢¢¢¢¢¢¢¢¢¢ ¢¢¢¢¢¢¢¢¢¢¢ ¢¢¢¢¢¢¢¢¢¢¢ Z¨urich Swiss Federal Institute of Technology Zurich hp-Finite Element Methods for Hyperbolic Problems E. S¨uli†, P. Houston† and C. Schwab ∗ Research Report No. 99-14 July 1999 Seminar f¨urAngewandte Mathematik Eidgen¨ossische Technische Hochschule CH-8092 Z¨urich Switzerland †Oxford University Computing Laboratory, Wolfson Building, Parks Road, Oxford OX1 3QD, United Kingdom ∗E. S¨uliand P. Houston acknowledge the financial support of the EPSRC (Grant GR/K76221) hp-Finite Element Methods for Hyperbolic Problems E. S¨uli†, P. Houston† and C. Schwab ∗ Seminar f¨urAngewandte Mathematik Eidgen¨ossische Technische Hochschule CH-8092 Z¨urich Switzerland Research Report No. 99-14 July 1999 Abstract This paper is devoted to the a priori and a posteriori error analysis of the hp-version of the discontinuous Galerkin finite element method for partial differential equations of hyperbolic and nearly-hyperbolic character. We consider second-order partial dif- ferential equations with nonnegative characteristic form, a large class of equations which includes convection-dominated diffusion problems, degenerate elliptic equa- tions and second-order problems of mixed elliptic-hyperbolic-parabolic type. An a priori error bound is derived for the method in the so-called DG-norm which is optimal in terms of the mesh size h; the error bound is either 1 degree or 1/2 de- gree below optimal in terms of the polynomial degree p, depending on whether the problem is convection-dominated, or diffusion-dominated, respectively. In the case of a first-order hyperbolic equation the error bound is hp-optimal in the DG-norm.
    [Show full text]
  • Finite Difference and Discontinuous Galerkin Methods for Wave Equations
    Digital Comprehensive Summaries of Uppsala Dissertations from the Faculty of Science and Technology 1522 Finite Difference and Discontinuous Galerkin Methods for Wave Equations SIYANG WANG ACTA UNIVERSITATIS UPSALIENSIS ISSN 1651-6214 ISBN 978-91-554-9927-3 UPPSALA urn:nbn:se:uu:diva-320614 2017 Dissertation presented at Uppsala University to be publicly examined in Room 2446, Polacksbacken, Lägerhyddsvägen 2, Uppsala, Tuesday, 13 June 2017 at 10:15 for the degree of Doctor of Philosophy. The examination will be conducted in English. Faculty examiner: Professor Thomas Hagstrom (Department of Mathematics, Southern Methodist University). Abstract Wang, S. 2017. Finite Difference and Discontinuous Galerkin Methods for Wave Equations. Digital Comprehensive Summaries of Uppsala Dissertations from the Faculty of Science and Technology 1522. 53 pp. Uppsala: Acta Universitatis Upsaliensis. ISBN 978-91-554-9927-3. Wave propagation problems can be modeled by partial differential equations. In this thesis, we study wave propagation in fluids and in solids, modeled by the acoustic wave equation and the elastic wave equation, respectively. In real-world applications, waves often propagate in heterogeneous media with complex geometries, which makes it impossible to derive exact solutions to the governing equations. Alternatively, we seek approximated solutions by constructing numerical methods and implementing on modern computers. An efficient numerical method produces accurate approximations at low computational cost. There are many choices of numerical methods for solving partial differential equations. Which method is more efficient than the others depends on the particular problem we consider. In this thesis, we study two numerical methods: the finite difference method and the discontinuous Galerkin method.
    [Show full text]
  • A Quasi-Static Particle-In-Cell Algorithm Based on an Azimuthal Fourier Decomposition for Highly Efficient Simulations of Plasma-Based Acceleration
    A quasi-static particle-in-cell algorithm based on an azimuthal Fourier decomposition for highly efficient simulations of plasma-based acceleration: QPAD Fei Lia,c, Weiming And,∗, Viktor K. Decykb, Xinlu Xuc, Mark J. Hoganc, Warren B. Moria,b aDepartment of Electrical Engineering, University of California Los Angeles, Los Angeles, CA 90095, USA bDepartment of Physics and Astronomy, University of California Los Angeles, Los Angeles, CA 90095, USA cSLAC National Accelerator Laboratory, Menlo Park, CA 94025, USA dDepartment of Astronomy, Beijing Normal University, Beijing 100875, China Abstract The three-dimensional (3D) quasi-static particle-in-cell (PIC) algorithm is a very effi- cient method for modeling short-pulse laser or relativistic charged particle beam-plasma interactions. In this algorithm, the plasma response, i.e., plasma wave wake, to a non- evolving laser or particle beam is calculated using a set of Maxwell's equations based on the quasi-static approximate equations that exclude radiation. The plasma fields are then used to advance the laser or beam forward using a large time step. The algorithm is many orders of magnitude faster than a 3D fully explicit relativistic electromagnetic PIC algorithm. It has been shown to be capable to accurately model the evolution of lasers and particle beams in a variety of scenarios. At the same time, an algorithm in which the fields, currents and Maxwell equations are decomposed into azimuthal harmonics has been shown to reduce the complexity of a 3D explicit PIC algorithm to that of a 2D algorithm when the expansion is truncated while maintaining accuracy for problems with near azimuthal symmetry.
    [Show full text]
  • A Discontinuous Galerkin Method for Nonlinear Parabolic Equations and Gradient flow Problems with Interaction Potentials
    A discontinuous Galerkin method for nonlinear parabolic equations and gradient flow problems with interaction potentials Zheng Sun1, Jos´eA. Carrillo2 and Chi-Wang Shu3 Abstract We consider a class of time dependent second order partial differential equations governed by a decaying entropy. The solution usually corresponds to a density distribution, hence positivity (non-negativity) is expected. This class of problems covers important cases such as Fokker-Planck type equations and aggregation models, which have been studied intensively in the past decades. In this paper, we design a high order discontinuous Galerkin method for such problems. If the interaction potential is not involved, or the interaction is defined by a smooth kernel, our semi-discrete scheme admits an entropy inequality on the discrete level. Furthermore, by applying the positivity-preserving limiter, our fully discretized scheme produces non-negative solutions for all cases under a time step constraint. Our method also applies to two dimensional problems on Cartesian meshes. Numerical examples are given to confirm the high order accuracy for smooth test cases and to demonstrate the effectiveness for preserving long time asymptotics. Keywords: discontinuous Galerkin method, positivity-preserving, entropy-entropy dissipation relationship, nonlinear parabolic equation, gradient flow 1Division of Applied Mathematics, Brown University, Providence, RI 02912, USA. E-mail: zheng [email protected] 2Department of Mathematics, Imperial College London, London SW7 2AZ, UK. E-mail: car- [email protected]. Research supported by the Royal Society via a Wolfson Research Merit Award and by EPSRC grant number EP/P031587/1. 3Division of Applied Mathematics, Brown University, Providence, RI 02912, USA. E-mail: [email protected].
    [Show full text]
  • A Numerical Method of Characteristics for Solving Hyperbolic Partial Differential Equations David Lenz Simpson Iowa State University
    Iowa State University Capstones, Theses and Retrospective Theses and Dissertations Dissertations 1967 A numerical method of characteristics for solving hyperbolic partial differential equations David Lenz Simpson Iowa State University Follow this and additional works at: https://lib.dr.iastate.edu/rtd Part of the Mathematics Commons Recommended Citation Simpson, David Lenz, "A numerical method of characteristics for solving hyperbolic partial differential equations " (1967). Retrospective Theses and Dissertations. 3430. https://lib.dr.iastate.edu/rtd/3430 This Dissertation is brought to you for free and open access by the Iowa State University Capstones, Theses and Dissertations at Iowa State University Digital Repository. It has been accepted for inclusion in Retrospective Theses and Dissertations by an authorized administrator of Iowa State University Digital Repository. For more information, please contact [email protected]. This dissertation has been microfilmed exactly as received 68-2862 SIMPSON, David Lenz, 1938- A NUMERICAL METHOD OF CHARACTERISTICS FOR SOLVING HYPERBOLIC PARTIAL DIFFERENTIAL EQUATIONS. Iowa State University, PluD., 1967 Mathematics University Microfilms, Inc., Ann Arbor, Michigan A NUMERICAL METHOD OF CHARACTERISTICS FOR SOLVING HYPERBOLIC PARTIAL DIFFERENTIAL EQUATIONS by David Lenz Simpson A Dissertation Submitted to the Graduate Faculty in Partial Fulfillment of The Requirements for the Degree of DOCTOR OF PHILOSOPHY Major Subject: Mathematics Approved: Signature was redacted for privacy. In Cijarge of Major Work Signature was redacted for privacy. Headead of^ajorof Major DepartmentDepartmen Signature was redacted for privacy. Dean Graduate Co11^^ Iowa State University of Science and Technology Ames, Iowa 1967 ii TABLE OF CONTENTS Page I. INTRODUCTION 1 II. DISCUSSION OF THE ALGORITHM 3 III. DISCUSSION OF LOCAL ERROR, EXISTENCE AND UNIQUENESS THEOREMS 10 IV.
    [Show full text]
  • Robust Adaptive Hp Discontinuous Galerkin Finite Element Methods For
    Robust adaptive hp discontinuous Galerkin finite element methods for the Helmholtz equation∗ Scott Congrevey Joscha Gedickez Ilaria Perugiax Abstract This paper presents an hp a posteriori error analysis for the 2D Helmholtz equation that is robust in the polynomial degree p and the wave number k. For the discretization, we consider a discontinuous Galerkin formulation that is unconditionally well posed. The a posteriori error analysis is based on the technique of equilibrated fluxes applied to a shifted Poisson problem, with the error due to the nonconformity of the discretization controlled by a potential reconstruction. We prove that the error estimator is both reliable and efficient, under the condition that the initial mesh size and polynomial degree is chosen such that the discontinuous Galerkin formulation converges, i.e., it is out of the regime of pollution. We confirm the efficiency of an hp-adaptive refinement strategy based on the presented robust a posteriori error estimator via several numerical examples. Keywords a posteriori error analysis, hp discontinuous Galerkin finite element method, equilibrated fluxes, potential reconstruction, Helmholtz problem AMS subject classification 65N15, 65N30, 65N50 1 Introduction In this paper, we consider the following Helmholtz problem with impedance boundary condition: Find a (complex) solution u 2 H2(Ω) such that −∆u − k2u = f in Ω; (1.1) ru · n − iku = g on @Ω; where Ω ⊂ R2 is a bounded, Lipschitz domain, n denotes the outer unit normal on the boundary @Ω, f 2 L2(Ω), g 2 L2(@Ω), and k > 0 is the (constant) wavenumber. The problem (1.1) was shown to be well-posed in [18].
    [Show full text]
  • Analysis of Finite Difference Discretization Schemes For
    Computers and Chemical Engineering 71 (2014) 241–252 Contents lists available at ScienceDirect Computers and Chemical Engineering j ournal homepage: www.elsevier.com/locate/compchemeng Analysis of finite difference discretization schemes for diffusion in spheres with variable diffusivity ∗ Ashlee N. Ford Versypt, Richard D. Braatz Department of Chemical Engineering, Massachusetts Institute of Technology, Cambridge, MA 02139, USA a r t i c l e i n f o a b s t r a c t Article history: Two finite difference discretization schemes for approximating the spatial derivatives in the diffusion Received 28 April 2014 equation in spherical coordinates with variable diffusivity are presented and analyzed. The numerical Accepted 27 May 2014 solutions obtained by the discretization schemes are compared for five cases of the functional form Available online 27 August 2014 for the variable diffusivity: (I) constant diffusivity, (II) temporally dependent diffusivity, (III) spatially dependent diffusivity, (IV) concentration-dependent diffusivity, and (V) implicitly defined, temporally Keywords: and spatially dependent diffusivity. Although the schemes have similar agreement to known analytical Finite difference method or semi-analytical solutions in the first four cases, in the fifth case for the variable diffusivity, one scheme Variable coefficient Diffusion produces a stable, physically reasonable solution, while the other diverges. We recommend the adoption of the more accurate and stable of these finite difference discretization schemes to numerically approxi- Spherical geometry Method of lines mate the spatial derivatives of the diffusion equation in spherical coordinates for any functional form of variable diffusivity, especially cases where the diffusivity is a function of position. © 2014 Elsevier Ltd.
    [Show full text]
  • Optimal Strong-Stability-Preserving Runge–Kutta Time Discretizations for Discontinuous Galerkin Methods
    Journal of Scientific Computing manuscript No. (will be inserted by the editor) Optimal strong-stability-preserving Runge–Kutta time discretizations for discontinuous Galerkin methods Ethan J. Kubatko · Benjamin A. Yeager · David I. Ketcheson Received: date / Accepted: date Abstract Discontinuous Galerkin (DG) spatial discretizations are often used in a method-of-lines approach with explicit strong-stability-preserving (SSP) Runge– Kutta (RK) time steppers for the numerical solution of hyperbolic conservation laws. The time steps that are employed in this type of approach must satisfy Courant–Friedrichs–Lewy (CFL) stability constraints that are dependent on both the region of absolute stability and the SSP coefficient of the RK method. While existing SSPRK methods have been optimized with respect to the latter, it is in fact the former that gives rise to stricter constraints on the time step in the case of RKDG stability. Therefore, in this work, we present the development of new “DG-optimized” SSPRK methods with stability regions that have been specifically designed to maximize the stable time step size for RKDG methods of a given order in one space dimension. These new methods represent the best available RKDG methods in terms of computational efficiency, with significant improvements over methods using existing SSPRK time steppers that have been optimized with re- spect to SSP coefficients. Second-, third-, and fourth-order methods with up to eight stages are presented, and their stability properties are verified through ap- plication to numerical test cases. Keywords discontinuous Galerkin · Runge–Kutta · strong-stability-preserving E. Kubatko Department of Civil, Environmental, and Geodetic Engineering, The Ohio State University, 2070 Neil Avenue, Columbus, OH 43210, United States Tel.: 614-292-7176 E-mail: [email protected] B.
    [Show full text]
  • A Bddc Algorithm for the Stokes Problem with Weak 2 Galerkin Discretizations
    1 A BDDC ALGORITHM FOR THE STOKES PROBLEM WITH WEAK 2 GALERKIN DISCRETIZATIONS 3 XUEMIN TU∗ AND BIN WANGy 4 Abstract. The BDDC (balancing domain decomposition by constraints) methods have been 5 applied successfully to solve the large sparse linear algebraic systems arising from conforming finite 6 element discretizations of second order elliptic and Stokes problems. In this paper, the Stokes 7 equations are discretized using the weak Galerkin method, a newly developed nonconforming finite 8 element method. A BDDC algorithm is designed to solve the linear system such obtained. Edge/face 9 velocity interface average and mean subdomain pressure are selected for the coarse problem. The 10 condition number bounds of the BDDC preconditioned operator are analyzed, and the same rate 11 of convergence is obtained as for conforming finite element methods. Numerical experiments are 12 conducted to verify the theoretical results. 13 Key words. Discontinuous Galerkin, HDG, weak Galerkin, domain decomposition, BDDC, 14 Stokes, Saddle point problems, benign subspace 15 AMS subject classifications. 65F10, 65N30, 65N55 16 1. Introduction. Numerical solution of saddle point problems using non over- 17 lapping domain decomposition methods have long been an active area of research; see, 18 e.g., [28, 15, 11, 10, 18, 29, 30, 16, 33, 17, 34, 27]. The Balancing Domain Decomposi- 19 tion by Constraints (BDDC) algorithm is an advanced variant of the non-overlapping 20 domain decomposition technique. It was first introduced by Dohrmann [5], and the 21 theoretical analysis was later given by Mandel and Dohrmann [20]. In this theoretical 22 development, optimal condition number bound was obtained for the BBDC opera- 23 tors proposed for symmetric positive definite systems.
    [Show full text]
  • Weighted Scheme and the Galerkin Method
    mathematics Article On the Numerical Simulation of HPDEs Using q-Weighted Scheme and the Galerkin Method Haifa Bin Jebreen *,† and Fairouz Tchier † Department of Mathematics, College of Science, King Saud University, Riyadh 11 551, Saudi Arabia; [email protected] * Correspondence: [email protected] † These authors contributed equally to this work. Abstract: Herein, an efficient algorithm is proposed to solve a one-dimensional hyperbolic partial differential equation. To reach an approximate solution, we employ the q-weighted scheme to discretize the time interval into a finite number of time steps. In each step, we have a linear ordinary differential equation. Applying the Galerkin method based on interpolating scaling functions, we can solve this ODE. Therefore, in each time step, the solution can be found as a continuous function. Stability, consistency, and convergence of the proposed method are investigated. Several numerical examples are devoted to show the accuracy and efficiency of the method and guarantee the validity of the stability, consistency, and convergence analysis. Keywords: interpolating scaling functions; hyperbolic equation; Galerkin method 1. Introduction Partial differential equations (PDEs) are ubiquitous in mathematically scientific fields and play an important role in engineering and physics. They arise from many purely math- ematical considerations, such as the calculus of variations and differential geometry. One of Citation: Bin Jebreen, H.; Tchier, F. On the momentous subclasses of PDEs is the hyperbolic partial differential equations (HPDEs). the Numerical Simulation of HPDEs HPDEs are used to model many phenomena such as biology, industry, atomic physics, and Using q-Weighted Scheme and the aerospace [1–3]. Telegraph and wave equations are the most famous types of HPDEs that Galerkin Method.
    [Show full text]