Research Statement

Total Page:16

File Type:pdf, Size:1020Kb

Research Statement RESEARCH STATEMENT Xuemin Tu 1 Overview My general research interest is in developing efficient numerical algorithms and applying them to real life problems. Particularly, I have been working on particle filters, domain decomposition algorithms, nonlinear multigrid methods. I have helped develop some special finite element methods for non-convex domains. I have also worked on some biomathematical projects such as the effect of cannibalism on flour beetle population dynamics and blood flow in stenotic collapsible tubes. 2 Previous Research Experiences and Accomplishments 2.1 Domain Decomposition Algorithms and Parallel Computation Usually the first step of solving a linear elliptic partial differential equation (PDE) numerically is its discretization. Finite difference, finite element, or other discretization methods reduce the original PDE to an often huge and ill-conditioned linear system of algebraic equations Au = f. (1) Limited by the memory and speed of computers, the traditional direct solvers often cannot han- dle such large linear systems. Also, iterative methods, such as Krylov space methods, can need thousands of iterations to obtain accurate solutions due to large condition numbers of such systems. If we can find a matrix P such that P −1A has a smaller condition number than A and P −1 acting on a vector is much easier to compute than for A−1, we can then solve −1 −1 P Au = P f, (2) instead of (1). This will need much fewer iterations when we use Krylov space methods because of the much smaller condition number of P −1A. We call the matrix P −1 a preconditioner of A. Domain decomposition methods provide efficient preconditioners that can be accelerated by Krylov space methods. They have become popular in applications in computational fluid dynamics, structural engineering, electromagnetics, constrained optimization, etc. The basic idea of domain decomposition methods is to split the original huge problem into many small problems which can be handled by direct solvers, and then solve these smaller problems a number of times and accelerate the solution of the original problem with Krylov space methods. The preconditioner of a domain decomposition method can often be written as: N −1 T −1 T −1 P = Ri DiAi DiRi + R0 A0 R0. =1 kX 1 Here, we have decomposed our original domain Ω into subdomains Ωi, i = 1 · · · N. Ai is the local problem on subdomain Ωi and A0 is a coarse problem. Ri are restriction operators and Di are certain matrices of weights. There are two main classes of domain decomposition methods: overlapping Schwarz methods and iterative substructuring methods. One well-known family of the iterative substructuring do- main decomposition methods is the Balancing Domain Decomposition by Constraints (BDDC) algorithms, which were introduced and analyzed in [3, 14]. In BDDC algorithms, we first reduce the original system to a subdomain interface system (Schur complement). The local components of the BDDC preconditioners are the local Schur complements of the subdomains and the coarse com- ponent is given in term of a set of primal constraints chosen for each pair of adjacent subdomains. We can obtain condition number bounds of the form 2 −1 H κ(P A) ≤ C 1 + log . (3) BDDC h Here H is the diameter and h is the typical mesh size of subdomains and C is a constant independent of H and h. Combining this estimate and the convergence analysis of Krylov space methods, we can conclude that the rate of convergence of BDDC is independent of the number of subdomains but depends weakly on the problem size of each subdomain. These are efficient and scalable algorithms. For parallel computation, we can assign one or several subdomains to individual processors and the coarse problem to one processor or to each processor. In each iteration, the subdomain local problems of different processors are solved in parallel. The sizes of the subdomain local and coarse problems are much smaller than the original problem. Therefore, we can obtain a very good parallel efficiency with BDDC algorithms. The key issue in BDDC algorithms is how to choose the primal constraints which define the coarse problems. I have extended the BDDC algorithms to several new applications and will discuss them in some detail in Section 2.1.1. Domain decomposition methods not only provide efficient preconditioners, but can also be coupled directly to discretizations in some cases. In collaboration with Dr. Maksymilian Dryja of Warsaw University, Poland, we have developed a domain decomposition discretization for the heat equation suitable for parallel computation; see [5]. 2.1.1 Extensions of BDDC Algorithms I have extended the BDDC algorithms to scalar elliptic equation with two kinds of discretizations: namely mixed and hybrid finite element discretizations, which have many applications such as for flow in porous media. These discretizations give systems of equations of following form: T A B u F1 = . (4) " B 0 # " p # " F2 # The system matrix of (4) is symmetric indefinite with the matrix A symmetric, positive definite. The hybrid finite element discretization is equivalent to a nonconforming finite element method. We can reduce the original saddle point problem to a positive definite system for the pressure p by introducing Lagrange multipliers on the interface of the subdomains and by eliminating the velocity u in each subdomain. I then use the BDDC preconditioner to solve the interface problem for the Lagrange multipliers, which can be interpreted as an approximation to the trace of the pressure. 2 By enforcing a suitable set of constraints, I obtain the same convergence rate as for a conforming finite element case (3), see [20]. Using the mixed formulation, I obtain a saddle point problem which is closely related to that arising from the incompressible Stokes equations [13]. I first reduce the original problem to an interface problem with the solution in a benign space, which is a subspace in which the BDDC preconditioned operator is positive definite. I choose edge/face constraints to force the iterates into the benign space. The conjugate gradient methods can therefore be used to accelerate the convergence. I have proved a condition number bound as in (3) for this BDDC algorithm, see [19]. We have also considered BDDC algorithms for some symmetric indefinite and nonsymmetric positive definite problems. This is a joint work with Dr. Jing Li of Kent State University. For the symmetric indefinite case, we consider the following system of linear equations 2 Au = (K − σ M)u = f, (5) where K is the stiffness matrix, M is the mass matrix, and σ is a scalar. This system arises from a finite element discretization of the Helmholtz equation on bounded interior domains or from inverse iterations for eigenvalue problems. Our BDDC algorithm is motivated by the dual-primal finite element tearing and interconnecting algorithm (FETI-DP) for solving the time-harmonic wave propagation problems (FETI-DPH), which was first proposed by Farhat and Li in [6]. The FETI-DPH method has been shown to be parallel scalable by extensive experiments and has been applied to the simulation of elastic waves in structural dynamics problems, and to the simulation of sound waves in acoustic scattering problems. A key component in FETI-DPH, and our BDDC algorithm, is some plane waves incorporated in the coarse level problem to enhance the convergence rate. These plane waves represent exact solutions of the partial differential equation in free space. This idea was first introduced by Farhat, Macedo, and Lesoinne [7] with the FETI-H algorithm for solving the Helmholtz equations. We use the GMRES iterations for the BDDC preconditioned system. Under the condition that the diameters of the subdomains are small enough, we prove that the convergence rate of the GMRES iteration depends polylogarithmically on the dimension of the individual subdomain problems and that it improves with a decrease of the subdomain diameters. We also establish the spectral equivalence between the proposed BDDC algorithms and the FETI- DPH algorithms for solving (5). Therefore, a convergence analysis of FETI-DPH algorithms is also obtained, see [12]. The systems of linear equations arising from the finite element discretization of advection- diffusion equations are nonsymmetric, but usually positive definite. We proposed a BDDC precon- ditioner for this nonsymmetric but positive definite system. A preconditioned GMRES iteration is used to solve a Schur complement system of equations for the subdomain interface variables. A key component in this BDDC algorithm, is certain constraints related the flux across the sub- domain interface incorporated in the coarse level problem to enhance the convergence rate. A convergence rate estimate for the GMRES iteration is established, under the condition that the di- ameters of subdomains are small enough. It is independent of the number of subdomains and grows only slowly with the subdomain problem size. Numerical experiments for several two-dimensional advection-diffusion problems illustrate the fast convergence of this algorithm, see [24]. 2.1.2 Three-level BDDC Algorithms One of the shortcoming of the BDDC methods is that the coarse problem needs to be generated and factored by a direct solver at the beginning of the computation. The number of primal constraints 3 selected for each subdomain must be large enough to make sure that the preconditioned system has the condition number bound as in (3). The coarse component can therefore be a bottleneck if the number of subdomains is very large. Motivated by this, I have developed two three-level BDDC algorithms to remove this difficulty. I group several subdomains together into a subregion and then use BDDC idea recursively for the coarse problem. I first reduce the original coarse problem to a subregion interface problem by eliminating the subregion interior variables independently. In the three-level BDDC algorithms, I do not solve the subregion interface problem exactly, but treat it by doing one iteration of the BDDC preconditioner.
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]
  • Newton-Krylov-BDDC Solvers for Nonlinear Cardiac Mechanics
    Newton-Krylov-BDDC solvers for nonlinear cardiac mechanics Item Type Article Authors Pavarino, L.F.; Scacchi, S.; Zampini, Stefano Citation Newton-Krylov-BDDC solvers for nonlinear cardiac mechanics 2015 Computer Methods in Applied Mechanics and Engineering Eprint version Post-print DOI 10.1016/j.cma.2015.07.009 Publisher Elsevier BV Journal Computer Methods in Applied Mechanics and Engineering Rights NOTICE: this is the author’s version of a work that was accepted for publication in Computer Methods in Applied Mechanics and Engineering. Changes resulting from the publishing process, such as peer review, editing, corrections, structural formatting, and other quality control mechanisms may not be reflected in this document. Changes may have been made to this work since it was submitted for publication. A definitive version was subsequently published in Computer Methods in Applied Mechanics and Engineering, 18 July 2015. DOI:10.1016/ j.cma.2015.07.009 Download date 07/10/2021 05:34:35 Link to Item http://hdl.handle.net/10754/561071 Accepted Manuscript Newton-Krylov-BDDC solvers for nonlinear cardiac mechanics L.F. Pavarino, S. Scacchi, S. Zampini PII: S0045-7825(15)00221-2 DOI: http://dx.doi.org/10.1016/j.cma.2015.07.009 Reference: CMA 10661 To appear in: Comput. Methods Appl. Mech. Engrg. Received date: 13 December 2014 Revised date: 3 June 2015 Accepted date: 8 July 2015 Please cite this article as: L.F. Pavarino, S. Scacchi, S. Zampini, Newton-Krylov-BDDC solvers for nonlinear cardiac mechanics, Comput. Methods Appl. Mech. Engrg. (2015), http://dx.doi.org/10.1016/j.cma.2015.07.009 This is a PDF file of an unedited manuscript that has been accepted for publication.
    [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 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]
  • 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]
  • Boundary Particle Method with High-Order Trefftz Functions
    Copyright © 2010 Tech Science Press CMC, vol.13, no.3, pp.201-217, 2010 Boundary Particle Method with High-Order Trefftz Functions Wen Chen1;2, Zhuo-Jia Fu1;3 and Qing-Hua Qin3 Abstract: This paper presents high-order Trefftz functions for some commonly used differential operators. These Trefftz functions are then used to construct boundary particle method for solving inhomogeneous problems with the boundary discretization only, i.e., no inner nodes and mesh are required in forming the final linear equation system. It should be mentioned that the presented Trefftz functions are nonsingular and avoids the singularity occurred in the fundamental solution and, in particular, have no problem-dependent parameter. Numerical experiments demonstrate the efficiency and accuracy of the present scheme in the solution of inhomogeneous problems. Keywords: High-order Trefftz functions, boundary particle method, inhomoge- neous problems, meshfree 1 Introduction Since the first paper on Trefftz method was presented by Trefftz (1926), its math- ematical theory was extensively studied by Herrera (1980) and many other re- searchers. In 1995 a special issue on Trefftz method, was published in the jour- nal of Advances in Engineering Software for celebrating its 70 years of develop- ment [Kamiya and Kita (1995)]. Qin (2000, 2005) presented an overview of the Trefftz finite element and its application in various engineering problems. The Trefftz method employs T-complete functions, which satisfies the governing dif- ferential operators and is widely applied to potential problems [Cheung, Jin and Zienkiewicz (1989)], two-dimensional elastic problems [Zielinski and Zienkiewicz (1985)], transient heat conduction [Jirousek and Qin (1996)], viscoelasticity prob- 1 Center for Numerical Simulation Software in Engineering and Sciences, Department of Engineer- ing Mechanics, Hohai University, Nanjing, Jiangsu, P.R.China 2 Corresponding author.
    [Show full text]
  • Preconditioning the Coarse Problem of BDDC Methods—Three-Level, Algebraic Multigrid, and Vertex-Based Preconditioners
    Electronic Transactions on Numerical Analysis. Volume 51, pp. 432–450, 2019. ETNA Kent State University and Copyright c 2019, Kent State University. Johann Radon Institute (RICAM) ISSN 1068–9613. DOI: 10.1553/etna_vol51s432 PRECONDITIONING THE COARSE PROBLEM OF BDDC METHODS— THREE-LEVEL, ALGEBRAIC MULTIGRID, AND VERTEX-BASED PRECONDITIONERS∗ AXEL KLAWONNyz, MARTIN LANSERyz, OLIVER RHEINBACHx, AND JANINE WEBERy Abstract. A comparison of three Balancing Domain Decomposition by Constraints (BDDC) methods with an approximate coarse space solver using the same software building blocks is attempted for the first time. The comparison is made for a BDDC method with an algebraic multigrid preconditioner for the coarse problem, a three-level BDDC method, and a BDDC method with a vertex-based coarse preconditioner. It is new that all methods are presented and discussed in a common framework. Condition number bounds are provided for all approaches. All methods are implemented in a common highly parallel scalable BDDC software package based on PETSc to allow for a simple and meaningful comparison. Numerical results showing the parallel scalability are presented for the equations of linear elasticity. For the first time, this includes parallel scalability tests for a vertex-based approximate BDDC method. Key words. approximate BDDC, three-level BDDC, multilevel BDDC, vertex-based BDDC AMS subject classifications. 68W10, 65N22, 65N55, 65F08, 65F10, 65Y05 1. Introduction. During the last decade, approximate variants of the BDDC (Balanc- ing Domain Decomposition by Constraints) and FETI-DP (Finite Element Tearing and Interconnecting-Dual-Primal) methods have become popular for the solution of various linear and nonlinear partial differential equations [1,8,9, 12, 14, 15, 17, 19, 21, 24, 25].
    [Show full text]
  • Dear Colleagues
    Contents Part 1: Plenary Lectures The expanding role of applications in the development and validation of CFD at NASA D. M. Schuster .......…………………………………………….....…………………..………. Thermodynamically consistent systems of hyperbolic equations S. K. Godunov ...................................................................................................................................... Part 2: Keynote Lectures A brief history of shock-fitting M.D. Salas …………………………………………………………………....…..…………. Understanding aerodynamics using computers M.M. Hafez ……….............…………………………………………………………...…..………. Part 3: High-Order Methods A unifying discontinuous CPR formulation for the Navier-Stokes equations on mixed grids Z.J. Wang, H. Gao, T. Haga ………………………………………………………………................. Assessment of the spectral volume method on inviscid and viscous flows O. Chikhaoui, J. Gressier, G. Grondin .........……………………………………..............…..…. .... Runge–Kutta Discontinuous Galerkin method for multi–phase compressible flows V. Perrier, E. Franquet ..........…………………………………………..........………………..……... Energy stable WENO schemes of arbitrary order N.K. Yamaleev, M.H. Carpenter ……………………………………………………….............…… Part 4: Two-Phase Flow A hybrid method for two-phase flow simulations K. Dorogan, J.-M. Hérard, J.-P. Minier ……………………………………………..................…… HLLC-type Riemann solver for the Baer-Nunziato equations of compressible two-phase flow S.A. Tokareva, E.F. Toro ………………………………………………………………...........…… Parallel direct simulation Monte Carlo of two-phase gas-droplet
    [Show full text]
  • Domain Decomposition Methods for Problems in H(Curl)
    Domain Decomposition Methods for Problems in H (curl) by Juan Gabriel Calvo A dissertation submitted in partial fulfillment of the requirements for the degree of Doctor of Philosophy Department of Mathematics New York University September 2015 Professor Olof B. Widlund ©Juan Gabriel Calvo All rights reserved, 2015 Dedication To my family. iv Acknowledgements First, my deepest gratitude goes to my advisor Olof Widlund. I thank him profoundly for his direction, guidance, support and advice during four years. I would also like to thank the rest of my committee: Professors Berger, Good- man, O'Neil and Stadler. In addition, I also thank Dr. Clark Dohrmann of the SANDIA-Albuquerque laboratories for his help and comments throughout my re- search. Finally I thank my Alma Mater, Universidad de Costa Rica, for the support during my academic education at NYU. v Abstract Two domain decomposition methods for solving vector field problems posed in H(curl) and discretized with N´ed´elecfinite elements are considered. These finite elements are conforming in H(curl). A two-level overlapping Schwarz algorithm in two dimensions is analyzed, where the subdomains are only assumed to be uniform in the sense of Peter Jones. The coarse space is based on energy minimization and its dimension equals the number of interior subdomain edges. Local direct solvers are based on the overlapping subdomains. The bound for the condition number depends only on a few geometric parameters of the decomposition. This bound is independent of jumps in the coefficients across the interface between the subdomains for most of the different cases considered.
    [Show full text]
  • Multigrid Solvers for Immersed Finite Element Methods and Immersed Isogeometric Analysis
    Computational Mechanics https://doi.org/10.1007/s00466-019-01796-y ORIGINAL PAPER Multigrid solvers for immersed finite element methods and immersed isogeometric analysis F. de Prenter1,3 · C. V. Verhoosel1 · E. H. van Brummelen1 · J. A. Evans2 · C. Messe2,4 · J. Benzaken2,5 · K. Maute2 Received: 26 March 2019 / Accepted: 10 November 2019 © The Author(s) 2019 Abstract Ill-conditioning of the system matrix is a well-known complication in immersed finite element methods and trimmed isogeo- metric analysis. Elements with small intersections with the physical domain yield problematic eigenvalues in the system matrix, which generally degrades efficiency and robustness of iterative solvers. In this contribution we investigate the spectral prop- erties of immersed finite element systems treated by Schwarz-type methods, to establish the suitability of these as smoothers in a multigrid method. Based on this investigation we develop a geometric multigrid preconditioner for immersed finite element methods, which provides mesh-independent and cut-element-independent convergence rates. This preconditioning technique is applicable to higher-order discretizations, and enables solving large-scale immersed systems at a computational cost that scales linearly with the number of degrees of freedom. The performance of the preconditioner is demonstrated for conventional Lagrange basis functions and for isogeometric discretizations with both uniform B-splines and locally refined approximations based on truncated hierarchical B-splines. Keywords Immersed finite element method · Fictitious domain method · Iterative solver · Preconditioner · Multigrid 1 Introduction [14–21], scan based analysis [22–27] and topology optimiza- tion, e.g., [28–34]. Immersed methods are useful tools to avoid laborious and An essential aspect of finite element methods and iso- computationally expensive procedures for the generation of geometric analysis is the computation of the solution to a body-fitted finite element discretizations or analysis-suitable system of equations.
    [Show full text]