PDF Download Numerical Approximation of Partial Differential

Total Page:16

File Type:pdf, Size:1020Kb

PDF Download Numerical Approximation of Partial Differential NUMERICAL APPROXIMATION OF PARTIAL DIFFERENTIAL EQUATIONS PDF, EPUB, EBOOK Alfio Quarteroni, Alberto Valli | 544 pages | 01 Nov 2008 | Springer-Verlag Berlin and Heidelberg GmbH & Co. KG | 9783540852674 | English | Berlin, Germany The Numerical Approximation of Stochastic Partial Differential Equations | SpringerLink MOL allows standard, general-purpose methods and software, developed for the numerical integration of ordinary differential equations ODEs and differential algebraic equations DAEs , to be used. A large number of integration routines have been developed over the years in many different programming languages, and some have been published as open source resources. The method of lines most often refers to the construction or analysis of numerical methods for partial differential equations that proceeds by first discretizing the spatial derivatives only and leaving the time variable continuous. This leads to a system of ordinary differential equations to which a numerical method for initial value ordinary equations can be applied. The method of lines in this context dates back to at least the early s. The finite element method FEM is a numerical technique for finding approximate solutions to boundary value problems for differential equations. It uses variational methods the calculus of variations to minimize an error function and produce a stable solution. Analogous to the idea that connecting many tiny straight lines can approximate a larger circle, FEM encompasses all the methods for connecting many simple element equations over many small subdomains, named finite elements, to approximate a more complex equation over a larger domain. The gradient discretization method GDM is a numerical technique that encompasses a few standard or recent methods. It is based on the separate approximation of a function and of its gradient. Core properties allow the convergence of the method for a series of linear and nonlinear problems, and therefore all the methods that enter the GDM framework conforming and nonconforming finite element, mixed finite element, mimetic finite difference The finite-volume method is a method for representing and evaluating partial differential equations in the form of algebraic equations [LeVeque, ; Toro, ]. Similar to the finite difference method or finite element method , values are calculated at discrete places on a meshed geometry. In the finite volume method, volume integrals in a partial differential equation that contain a divergence term are converted to surface integrals , using the divergence theorem. These terms are then evaluated as fluxes at the surfaces of each finite volume. Because the flux entering a given volume is identical to that leaving the adjacent volume, these methods are conservative. Another advantage of the finite volume method is that it is easily formulated to allow for unstructured meshes. The method is used in many computational fluid dynamics packages. Spectral methods are techniques used in applied mathematics and scientific computing to numerically solve certain differential equations , often involving the use of the fast Fourier transform. The idea is to write the solution of the differential equation as a sum of certain "basis functions" for example, as a Fourier series , which is a sum of sinusoids and then to choose the coefficients in the sum that best satisfy the differential equation. Spectral methods and finite element methods are closely related and built on the same ideas; the main difference between them is that spectral methods use basis functions that are nonzero over the whole domain, while finite element methods use basis functions that are nonzero only on small subdomains. In other words, spectral methods take on a global approach while finite element methods use a local approach. Partially for this reason, spectral methods have excellent error properties, with the so-called "exponential convergence" being the fastest possible, when the solution is smooth. However, there are no known three-dimensional single domain spectral shock capturing results. Meshfree methods do not require a mesh connecting the data points of the simulation domain. Meshfree methods enable the simulation of some otherwise difficult types of problems, at the cost of extra computing time and programming effort. Domain decomposition methods solve a boundary value problem by splitting it into smaller boundary value problems on subdomains and iterating to coordinate the solution between adjacent subdomains. A coarse problem with one or few unknowns per subdomain is used to further coordinate the solution between the subdomains globally. The problems on the subdomains are independent, which makes domain decomposition methods suitable for parallel computing. Domain decomposition methods are typically used as preconditioners for Krylov space iterative methods , such as the conjugate gradient method or GMRES. In overlapping domain decomposition methods, the subdomains overlap by more than the interface. Overlapping domain decomposition methods include the Schwarz alternating method and the additive Schwarz method. Many domain decomposition methods can be written and analyzed as a special case of the abstract additive Schwarz method. In non-overlapping methods, the subdomains intersect only on their interface. In primal methods, such as Balancing domain decomposition and BDDC , the continuity of the solution across subdomain interface is enforced by representing the value of the solution on all neighboring subdomains by the same unknown. In dual methods, such as FETI , the continuity of the solution across the subdomain interface is enforced by Lagrange multipliers. Non-overlapping domain decomposition methods are also called iterative substructuring methods. Mortar methods are discretization methods for partial differential equations, which use separate discretization on nonoverlapping subdomains. The meshes on the subdomains do not match on the interface, and the equality of the solution is enforced by Lagrange multipliers, judiciously chosen to preserve the accuracy of the solution. In the engineering practice in the finite element method, continuity of solutions between non-matching subdomains is implemented by multiple-point constraints. Finite element simulations of moderate size models require solving linear systems with millions of unknowns. Several hours per time step is an average sequential run time, therefore, parallel computing is a necessity. Domain decomposition methods embody large potential for a parallelization of the finite element methods, and serve a basis for distributed, parallel computations. Multigrid MG methods in numerical analysis are a group of algorithms for solving differential equations using a hierarchy of discretizations. They are an example of a class of techniques called multiresolution methods , very useful in but not limited to problems exhibiting multiple scales of behavior. For example, many basic relaxation methods exhibit different rates of convergence for short- and long-wavelength components, suggesting these different scales be treated differently, as in a Fourier analysis approach to multigrid. The main idea of multigrid is to accelerate the convergence of a basic iterative method by global correction from time to time, accomplished by solving a coarse problem. This principle is similar to interpolation between coarser and finer grids. Anderson: Modern compressible flow with historical perspective, 2nd ed. Vincenti and C. Kruger: Introduction to physical gas dynamics ; L. Landau and E. Lifschitz: Fluid Mechanics ; D. Acheson: Elementary Fluid Dynamics Chorin and J. Whitham: Linear and nonlinear waves ; M. Lax: Hyperbolic systems of conservation laws and the mathematical theory of shock waves ; J. Smoller: Shock waves and reaction-diffusion equations, 2nd ed. Godlewski and P-A Raviart: Numerical approximation of hyperbolic systems of conservation laws ; P. Lions: Mathematical Topics in Fluid Mechanics, v. Compressible Models B. Gustafsson, H-O Kreiss, J. Kreiss and J. Hirsch: Numerical computation of internal and external flows, v. Fundamentals of numerical discretization , v. Computational methods for inviscid and viscous flows. Richtmyer and K. Numerical Approximation of Partial Differential Equations | Alfio Quarteroni | Springer Browse our catalogue of tasks and access state-of-the-art solutions. Tip: you can also follow us on Twitter. You need to log in to edit. You can create a new account if you don't have one. Or, discuss a change on Slack. Official code from paper authors. There is no official implementation. Multiple official implementations. To add evaluation results you first need to add a task to this paper. Add: Not in the list? Create a new task. New task name:. Parent task if any : Description optional :. Create a new method. New method name e. Finite Difference Method. Pages Elliptic Partial Differential Equations. Finite Element Method. Local Resolution Techniques. Iterative Solution Methods. Saddle-Point Problems. Mixed and Nonstandard Methods. Back Matter Pages About this book Introduction Finite element methods for approximating partial differential equations have reached a high degree of maturity, and are an indispensible tool in science and technology. This textbook aims at providing a thorough introduction to the construction, analysis, and implementation of finite element methods for model problems arising in continuum mechanics. Numerical methods for ordinary differential equations - Wikipedia This paper develops
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]
  • A Parallel Preconditioner for a FETI-DP Method for the Crouzeix-Raviart finite Element
    A parallel preconditioner for a FETI-DP method for the Crouzeix-Raviart finite element Leszek Marcinkowski∗1 Talal Rahman2 1 Introduction In this paper, we present a Neumann-Dirichlet type parallel preconditioner for a FETI-DP method for the nonconforming Crouzeix-Raviart (CR) finite element dis- cretization of a model second order elliptic problem. The proposed method is almost optimal, in fact, the condition number of the preconditioned problem grows poly- logarithmically with respect to the mesh parameters of the local triangulations. In many scientific applications, where partial differential equations are used to model, the Crouzeix-Raviart (CR) finite element has been one of the most com- monly used nonconforming finite element for the numerical solution. This includes applications like the Poisson equation (cf. [11, 23]), the Darcy-Stokes problem (cf. [8]), the elasticity problem (cf. [3]). We also would like to add that there is a close relationship between mixed finite elements and the nonconforming finite element for the second order elliptic problem; cf. [1, 2]. The CR element has also been used in the framework of finite volume element method; cf. [9]. There exists quite a number of works focusing on iterative methods for the CR finite element for second order problems; cf. [4, 5, 10, 13, 16, 18, 19, 20, 21, 22] and references therein. The purpose of this paper is to propose a parallel algorithm based on a Neumann-Dirichlet preconditioner for a FETI-DP formulation of the CR finite element method for the second order elliptic problem. To our knowledge, this is apparently the first work on such preconditioner for the FETI-DP method for the Crouzeix-Raviart (CR) finite element.
    [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]
  • Coupling of the Finite Volume Element Method and the Boundary Element Method – an a Priori Convergence Result
    COUPLING OF THE FINITE VOLUME ELEMENT METHOD AND THE BOUNDARY ELEMENT METHOD – AN A PRIORI CONVERGENCE RESULT CHRISTOPH ERATH∗ Abstract. The coupling of the finite volume element method and the boundary element method is an interesting approach to simulate a coupled system of a diffusion convection reaction process in an interior domain and a diffusion process in the corresponding unbounded exterior domain. This discrete system maintains naturally local conservation and a possible weighted upwind scheme guarantees the stability of the discrete system also for convection dominated problems. We show existence and uniqueness of the continuous system with appropriate transmission conditions on the coupling boundary, provide a convergence and an a priori analysis in an energy (semi-) norm, and an existence and an uniqueness result for the discrete system. All results are also valid for the upwind version. Numerical experiments show that our coupling is an efficient method for the numerical treatment of transmission problems, which can be also convection dominated. Key words. finite volume element method, boundary element method, coupling, existence and uniqueness, convergence, a priori estimate 1. Introduction. The transport of a concentration in a fluid or the heat propa- gation in an interior domain often follows a diffusion convection reaction process. The influence of such a system to the corresponding unbounded exterior domain can be described by a homogeneous diffusion process. Such a coupled system is usually solved by a numerical scheme and therefore, a method which ensures local conservation and stability with respect to the convection term is preferable. In the literature one can find various discretization schemes to solve similar prob- lems.
    [Show full text]
  • Meshfree Methods Chapter 1 — Part 1: Introduction and a Historical Overview
    MATH 590: Meshfree Methods Chapter 1 — Part 1: Introduction and a Historical Overview Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2014 [email protected] MATH 590 – Chapter 1 1 Outline 1 Introduction 2 Some Historical Remarks [email protected] MATH 590 – Chapter 1 2 Introduction General Meshfree Methods Meshfree Methods have gained much attention in recent years interdisciplinary field many traditional numerical methods (finite differences, finite elements or finite volumes) have trouble with high-dimensional problems meshfree methods can often handle changes in the geometry of the domain of interest (e.g., free surfaces, moving particles and large deformations) better independence from a mesh is a great advantage since mesh generation is one of the most time consuming parts of any mesh-based numerical simulation new generation of numerical tools [email protected] MATH 590 – Chapter 1 4 Introduction General Meshfree Methods Applications Original applications were in geodesy, geophysics, mapping, or meteorology Later, many other application areas numerical solution of PDEs in many engineering applications, computer graphics, optics, artificial intelligence, machine learning or statistical learning (neural networks or SVMs), signal and image processing, sampling theory, statistics (kriging), response surface or surrogate modeling, finance, optimization. [email protected] MATH 590 – Chapter 1 5 Introduction General Meshfree Methods Complicated Domains Recent paradigm shift in numerical simulation of fluid
    [Show full text]
  • A Meshless Approach to Solving Partial Differential Equations Using the Finite Cloud Method for the Purposes of Computer Aided Design
    A Meshless Approach to Solving Partial Differential Equations Using the Finite Cloud Method for the Purposes of Computer Aided Design by Daniel Rutherford Burke, B.Eng A Thesis submitted to the Faculty of Graduate and Post Doctoral Affairs in partial fulfilment of the requirements for the degree of Doctor of Philosophy Ottawa Carleton Institute for Electrical and Computer Engineering Department of Electronics Carleton University Ottawa, Ontario, Canada January 2013 Library and Archives Bibliotheque et Canada Archives Canada Published Heritage Direction du 1+1 Branch Patrimoine de I'edition 395 Wellington Street 395, rue Wellington Ottawa ON K1A0N4 Ottawa ON K1A 0N4 Canada Canada Your file Votre reference ISBN: 978-0-494-94524-7 Our file Notre reference ISBN: 978-0-494-94524-7 NOTICE: AVIS: The author has granted a non­ L'auteur a accorde une licence non exclusive exclusive license allowing Library and permettant a la Bibliotheque et Archives Archives Canada to reproduce, Canada de reproduire, publier, archiver, publish, archive, preserve, conserve, sauvegarder, conserver, transmettre au public communicate to the public by par telecommunication ou par I'lnternet, preter, telecommunication or on the Internet, distribuer et vendre des theses partout dans le loan, distrbute and sell theses monde, a des fins commerciales ou autres, sur worldwide, for commercial or non­ support microforme, papier, electronique et/ou commercial purposes, in microform, autres formats. paper, electronic and/or any other formats. The author retains copyright L'auteur conserve la propriete du droit d'auteur ownership and moral rights in this et des droits moraux qui protege cette these. Ni thesis. Neither the thesis nor la these ni des extraits substantiels de celle-ci substantial extracts from it may be ne doivent etre imprimes ou autrement printed or otherwise reproduced reproduits sans son autorisation.
    [Show full text]
  • A Plane Wave Method Based on Approximate Wave Directions for Two
    A PLANE WAVE METHOD BASED ON APPROXIMATE WAVE DIRECTIONS FOR TWO DIMENSIONAL HELMHOLTZ EQUATIONS WITH LARGE WAVE NUMBERS QIYA HU AND ZEZHONG WANG Abstract. In this paper we present and analyse a high accuracy method for computing wave directions defined in the geometrical optics ansatz of Helmholtz equation with variable wave number. Then we define an “adaptive” plane wave space with small dimensions, in which each plane wave basis function is determined by such an approximate wave direction. We establish a best L2 approximation of the plane wave space for the analytic solutions of homogeneous Helmholtz equa- tions with large wave numbers and report some numerical results to illustrate the efficiency of the proposed method. Key words. Helmholtz equations, variable wave numbers, geometrical optics ansatz, approximate wave direction, plane wave space, best approximation AMS subject classifications. 65N30, 65N55. 1. Introduction In this paper we consider the following Helmholtz equation with impedance boundary condition u = (∆ + κ2(r))u(ω, r)= f(ω, r), r = (x, y) Ω, L − ∈ (1.1) ((∂n + iκ(r))u(ω, r)= g(ω, r), r ∂Ω, ∈ where Ω R2 is a bounded Lipchitz domain, n is the out normal vector on ∂Ω, ⊂ f L2(Ω) is the source term and κ(r) = ω , g L2(∂Ω). In applications, ω ∈ c(r) ∈ denotes the frequency and may be large, c(r) > 0 denotes the light speed, which is arXiv:2107.09797v1 [math.NA] 20 Jul 2021 usually a variable positive function. The number κ(r) is called the wave number. Helmholtz equation is the basic model in sound propagation.
    [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]
  • Family Name Given Name Presentation Title Session Code
    Family Name Given Name Presentation Title Session Code Abdoulaev Gassan Solving Optical Tomography Problem Using PDE-Constrained Optimization Method Poster P Acebron Juan Domain Decomposition Solution of Elliptic Boundary Value Problems via Monte Carlo and Quasi-Monte Carlo Methods Formulations2 C10 Adams Mark Ultrascalable Algebraic Multigrid Methods with Applications to Whole Bone Micro-Mechanics Problems Multigrid C7 Aitbayev Rakhim Convergence Analysis and Multilevel Preconditioners for a Quadrature Galerkin Approximation of a Biharmonic Problem Fourth-order & ElasticityC8 Anthonissen Martijn Convergence Analysis of the Local Defect Correction Method for 2D Convection-diffusion Equations Flows C3 Bacuta Constantin Partition of Unity Method on Nonmatching Grids for the Stokes Equations Applications1 C9 Bal Guillaume Some Convergence Results for the Parareal Algorithm Space-Time ParallelM5 Bank Randolph A Domain Decomposition Solver for a Parallel Adaptive Meshing Paradigm Plenary I6 Barbateu Mikael Construction of the Balancing Domain Decomposition Preconditioner for Nonlinear Elastodynamic Problems Balancing & FETIC4 Bavestrello Henri On Two Extensions of the FETI-DP Method to Constrained Linear Problems FETI & Neumann-NeumannM7 Berninger Heiko On Nonlinear Domain Decomposition Methods for Jumping Nonlinearities Heterogeneities C2 Bertoluzza Silvia The Fully Discrete Fat Boundary Method: Optimal Error Estimates Formulations2 C10 Biros George A Survey of Multilevel and Domain Decomposition Preconditioners for Inverse Problems in Time-dependent
    [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 Face-Centred Finite Volume Method for Second-Order Elliptic Problems
    A face-centred finite volume method for second-order elliptic problems Ruben Sevilla Zienkiewicz Centre for Computational Engineering, College of Engineering, Swansea University, Wales, UK Matteo Giacomini, and Antonio Huerta Laboratori de C`alculNum`eric(LaC`aN), ETS de Ingenieros de Caminos, Canales y Puertos, Universitat Polit`ecnicade Catalunya, Barcelona, Spain December 19, 2017 Abstract This work proposes a novel finite volume paradigm, the face-centred finite volume (FCFV) method. Contrary to the popular vertex (VCFV) and cell (CCFV) centred finite volume methods, the novel FCFV defines the solution on the mesh faces (edges in 2D) to construct locally-conservative numerical schemes. The idea of the FCFV method stems from a hybridisable discontinuous Galerkin (HDG) formulation with constant degree of approximation, thus inheriting the convergence properties of the classical HDG. The resulting FCFV features a global problem in terms of a piecewise constant function defined on the faces of the mesh. The solution and its gradient in each element are then recovered by solving a set of independent element-by-element problems. The mathematical formulation of FCFV for Poisson and Stokes equation is derived and numerical evidence of optimal convergence in 2D and 3D is provided. Numerical examples are presented to illustrate the accuracy, efficiency and robustness of the proposed methodology. The results show that, contrary to other FV methods, arXiv:1712.06173v1 [math.NA] 17 Dec 2017 the accuracy of the FCFV method is not sensitive to mesh distortion and stretching. In addition, the FCFV method shows its better performance, accuracy and robustness using simplicial elements, facilitating its application to problems involving complex geometries in 3D.
    [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]