RESEARCH STATEMENT 1. Overview. I Am Working on Developing

Total Page:16

File Type:pdf, Size:1020Kb

RESEARCH STATEMENT 1. Overview. I Am Working on Developing RESEARCH STATEMENT XUEMIN TU 1. Overview. I am working on developing efficient numerical algorithms for solving the system obtained from the discretization of partial differential equations (PDEs). Much of my work has so far been supervised by Professor Olof Widlund. Usually the first step of solving an elliptic partial differential equation (PDE) nu- merically is its discretization. Finite difference, finite element, or other discretizations reduce the original PDE to an often huge and ill-conditioned linear or nonlinear sys- tem of algebraic equations. Limited by the memory and speed of the computers, the traditional direct solvers can often not handle such large linear systems. Moreover, iterative methods, such as Krylov space methods, may need thousands of iterations to obtain accurate solutions due to large condition numbers. Domain decomposi- tion methods provide efficient and scalable preconditioners that can be accelerated by Krylov space methods and 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. There are two main classes of domain decomposition methods: overlapping Schwarz methods and iterative substructuring methods. My research focuses on the second ap- proach. In iterative substructuring methods, the domain is decomposed into nonover- lapping subdomains. The unknowns in the interior of the subdomains are first elim- inated independently and we then work with the Schur complement with respect to the unknowns associated with the interface. Coarse problems are constructed using one or a few degrees of freedom for each subdomain. Among these algorithms, the Neumann-Neumann and finite element tearing and interconnecting methods (FETI) families are the best known and they have been tested in many applications. Recently, a new family of iterative substructuring methods, the balancing do- main decomposition by constraints (BDDC) algorithms, has been introduced by Clark Dohrmann in [6]. These methods have a Neumann-Neumann flavor. However, their coarse problems are given by sets of constraints enforced on the interface, which are similar to those of the dual-primal FETI (FETI-DP) methods [11]. It has been proved that the preconditioned operators for BDDC and FETI-DP have identical nontrivial eigenvalues except possibly for 0 and 1, see [21, 18, 3]. The condition number of the preconditioned operators have the bound: 2 H (1.1) κ ≤ C 1 + log ; h where H is the diameter and h is the typical mesh size of subdomains and C is constant independent of H and h. Combining this estimate and the convergence analysis of Krylov space method, we can conclude that the rate of convergence of FETI-DP and BDDC both are independent of the number of subdomains but depend slightly on the problem size of each subdomain. They are efficient and scalable algorithms. However, a shortcoming of both BDDC, FETI-DP, and all other domain decom- position methods is that the coarse problem needs to be assembled and the resulting matrix needs to be factored by a direct solver at the beginning of the computation. 1 Usually the size of the coarse problem is proportional to the number of subdomains. Nowadays some computer systems have more than 100,000 powerful processors, which allow very large and detailed simulations. The coarse component can therefore be a bottleneck if the number of subdomains is very large. Motivated by this fact, I have developed two three-level BDDC algorithms to remove this difficulty. I have also extended the BDDC algorithms to flow in porous media and established the same condition number estimate for the preconditioned BDDC operator as in (1.1). I also worked with Professor Maksymilian Dryja on the using domain decomposi- tion method directly for parabolic problems and have obtained the best error estimate, to the best of our knowledge, for this type of discretization. In the summer 2005, I worked as a Givens associate in Mathematics and Computer science division at Argonne National Laboratory with Dr. Barry Smith on nonlinear multigrid for solving nonlinear PDEs. During my master study at Worcester Polytechnic Institute, I worked with my advisor Dr. Marcus Sarkis on enhanced singular function mortar finite element for nonconvex domains. I also worked with Professor Haiyang Huang on modeling the dynamics of flour beetle population at Beijing Normal University during my graduate study there. In the following sections, I describe these projects in detail and related future work. 2. Three-level BDDC. 2.1. Current work: Three-level BDDC for scalar elliptic problems in two and three dimensions. The BDDC algorithms, previously developed for two levels [6, 20, 21], are similar to the balancing Neumann-Neumann algorithms. How- ever, the coarse problem, in BDDC, is given in terms of a set of primal constraints and is generated and factored by direct solvers at the beginning of the computation. The coarse components of the preconditioners can then ultimately become a bottleneck if the number of subdomains is very large. We try to remove this difficulty by using one or several additional levels. We proceed as follows: we group several subdomains together to form a sub- region. We could first reduce the original coarse problem to a subregion interface problem by eliminating independently the subregion interior variables, which are the primal variables on the subdomain interface and interior to the subregions. In one of the three-level BDDC algorithms, we do not solve the subregion interface prob- lem exactly, but replace it by one iteration of the BDDC preconditioner; Dohrmann has also suggested this approach in [6]. This means that we only need to solve sev- eral subregion local problems and one coarse problem on the subregion level in each iteration. We assume that all these problems are small enough to be solved by di- rect solvers. We have shown that the condition number estimate for the resulting three-level preconditioned BDDC operator is bounded by 2 2 H^ H (2.1) κ ≤ C 1 + log 1 + log ; H h ! where H^ , H, and h are the typical diameters of the subregions, subdomains, and mesh of subdomains, respectively. C is constant independent of H^ , H, h, and the coefficients of the original PDE, provided that the coefficients of the PDE vary moderately in each subregion. 2 ^ 2 H In order to remove the additional factor 1 + log H in (2.1), we can use a Chebyshev iteration method to accelerate the three-levelBDDC algorithms. With this device, the condition number bound is 2 H (2.2) κ ≤ CC(k) 1 + log ; h where C(k) depends on the eigenvalues of the preconditioned coarse problem, the two parameters chosen for the Chebyshev iteration, and k, the number of the Chebyshev iterations. C(k) goes to 1 as k goes to 1. H and h are the same as before. We first obtained these results for two dimensional problem with vertex con- straints, see [29]. We then extended these algorithms to the three dimensional cases, see [33]. In the three dimensional case, vertex constraints alone are not enough to obtain good polylogarithmic condition number bound (1.1) due to much weaker inter- polation estimate and constraints on the averages over edges or faces are needed. The new constraints lead to a considerably more complicated coarse problem and the need for new technical tools in the analysis. The same condition number bounds (2.1) and (2.2) with Chebyshev acceleration are obtained for three dimensional cases in [33]. 2.2. Future work. Our three-level BDDC algorithms are one of the inexact BDDC methods. Recently, there are several new results which have been reported, [32, 19, 16, 5]. BDDC has been extended to incompressible Stokes equations [17], flow in porous media [30, 31], and with mortar finite element discretization [15]. I will continue to work on extending our three-level BDDC algorithms to these problems, successfully extending the two-level BDDC methods. Among these, a three-level BDDC method with mortar finite element discretization is joint work with Dr. Hyea Hyun Kim. 3. BDDC algorithm for flow in porous media. We have extended BDDC algorithm for flow in porous media with two kinds of discretizations: mixed and hybrid finite element discretizations. 3.1. A BDDC algorithm for a mixed formulation of flow in porous me- dia. Using mixed formulations of flow in porous media, we obtain a saddle point problem which is closely related to that arising from the incompressible Stokes equa- tions. In a recent paper [17], the BDDC algorithms have been applied to the incom- pressible Stokes equation. Our situation is different. First of all, our problem is not originally formulated in the benign, divergence free subspace, and it will therefore be reduced to the benign subspace, as in [10, 22, 23, 24], at the beginning of the computation. In addition, only edge/face constraints are needed to force the iterates into the benign subspace and to ensure a good bound for the condition number, since Raviart-Thomas finite elements, see [4, Chapter III], are utilized. These elements have no degrees of freedom associated with vertices/edges in two/three dimensions. Also, the condition number estimate for the Stokes case can be simplified since the Stokes extension is equivalent to the harmonic extension, see [2]. However, this is not the case here, and different technical tools are required. An iterative substructuring method with Raviart-Thomas finite elements for vector field problems was proposed in [35, 27]. We have borrowed some technical tools from these papers and proven the condition number bound (1.1) for this BDDC algorithm, see [30].
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]
  • Phd Thesis, Universit´Elibre De Bruxelles, Chauss´Eede Waterloo, 72, 1640 Rhode- St-Gen`Ese,Belgium, 2004
    Universit´eLibre de Bruxelles von Karman Institute for Fluid Dynamics Aeronautics and Aerospace Department PhD. Thesis Algorithmic Developments for a Multiphysics Framework Thomas Wuilbaut Promoter: Prof. Herman Deconinck Contact information: Thomas Wuilbaut von Karman Institute for Fluid Dynamics 72 Chauss´eede Waterloo 1640 Rhode-St-Gen`ese BELGIUM email: [email protected] webpage: http://www.vki.ac.be/~wuilbaut To Olivia and her wonderful mother... Summary v Summary In this doctoral work, we adress various problems arising when dealing with multi-physical simulations using a segregated (non-monolithic) approach. We concentrate on a few specific problems and focus on the solution of aeroelastic flutter for linear elastic structures in compressible flows, conju- gate heat transfer for re-entry vehicles including thermo-chemical reactions and finally, industrial electro-chemical plating processes which often include stiff source terms. These problems are often solved using specifically devel- oped solvers, but these cannot easily be reused for different purposes. We have therefore considered the development of a flexible and reusable software platform for the simulation of multi-physics problems. We have based this development on the COOLFluiD framework developed at the von Karman Institute in collaboration with a group of partner institutions. For the solution of fluid flow problems involving compressible flows, we have used the Finite Volume method and we have focused on the applica- tion of the method to moving and deforming computational domains using the Arbitrary Lagrangian Eulerian formulation. Validation on a series of testcases (including turbulence) is shown. In parallel, novel time integration methods have been derived from two popular time discretization methods.
    [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]
  • Multigrid and Saddle-Point Preconditioners for Unfitted Finite
    Multigrid and saddle-point preconditioners for unfitted finite element modelling of inclusions Hardik Kothari∗and Rolf Krause† Institute of Computational Science, Universit`adella Svizzera italiana, Lugano, Switzerland February 17, 2021 Abstract In this work, we consider the modeling of inclusions in the material using an unfitted finite element method. In the unfitted methods, structured background meshes are used and only the underlying finite element space is modified to incorporate the discontinuities, such as inclusions. Hence, the unfitted methods provide a more flexible framework for modeling the materials with multiple inclusions. We employ the method of Lagrange multipliers for enforcing the interface conditions between the inclusions and matrix, this gives rise to the linear system of equations of saddle point type. We utilize the Uzawa method for solving the saddle point system and propose preconditioning strategies for primal and dual systems. For the dual systems, we review and compare the preconditioning strategies that are developed for FETI and SIMPLE methods. While for the primal system, we employ a tailored multigrid method specifically developed for the unfitted meshes. Lastly, the comparison between the proposed preconditioners is made through several numerical experiments. Keywords: Unfitted finite element method, multigrid method, saddle-point problem 1 Introduction In the modeling of many real-world engineering problems, we encounter material discontinuities, such as inclusions. The inclusions are found naturally in the materials, or can be artificially introduced to produce desired mechanical behavior. The finite element (FE) modeling of such inclusions requires to generate meshes that can resolve the interface between the matrix and inclusions, which can be a computationally cumbersome and expensive task.
    [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]
  • Méthode De Décomposition De Domaine Avec Adaptation De
    UNIVERSIT E´ PARIS 13 No attribu´epar la biblioth`eque TH ESE` pour obtenir le grade de DOCTEUR DE L’UNIVERSIT E´ PARIS 13 Discipline: Math´ematiques Appliqu´ees Laboratoire d’accueil: ONERA - Le centre fran¸cais de recherche a´erospatiale Pr´esent´ee et soutenue publiquement le 19 d´ecembre 2014 par Oana Alexandra CIOBANU Titre M´ethode de d´ecomposition de domaine avec adaptation de maillage en espace-temps pour les ´equations d’Euler et de Navier–Stokes devant le jury compos´ede: Fran¸cois Dubois Rapporteur Laurence Halpern Directrice de th`ese Rapha`ele Herbin Rapporteure Xavier Juvigny Examinateur Olivier Lafitte Examinateur Juliette Ryan Encadrante UNIVERSITY PARIS 13 THESIS Presented for the degree of DOCTEUR DE L’UNIVERSIT E´ PARIS 13 In Applied Mathematics Hosting laboratory: ONERA - The French Aerospace Lab presented for public discussion on 19 decembre 2014 by Oana Alexandra CIOBANU Subject Adaptive Space-Time Domain Decomposition Methods for Euler and Navier–Stokes Equations Jury: Fran¸cois Dubois Reviewer Laurence Halpern Supervisor Rapha`ele Herbin Reviewer Xavier Juvigny Examiner Olivier Lafitte Examiner Juliette Ryan Supervisor newpage Remerciements Tout d’abord, je remercie grandement Juliette Ryan pour avoir accept´e d’ˆetre mon encad- rante de stage puis mon encadrante de th`ese. Pendant plus de trois ans, elle m’a fait d´ecouvrir mon m´etier de jeune chercheuse avec beaucoup de patience et de professionnalisme. Elle m’a soutenue, elle a ´et´ed’une disponibilit´eet d’une ´ecoute extraordinaires, tout en sachant ˆetre rigoureuse et exigeante avec moi comme avec elle-mˆeme. Humainement, j’ai beaucoup appr´eci´e la relation d’amiti´eque nous avons entretenue, le climat de confiance que nous avons maintenu et les discussions extra-math´ematiques que nous avons pu avoir et qui ont renforc´ele lien que nous avions.
    [Show full text]
  • A FETI-DP Method for the Parallel Iterative Solution of Indefinite And
    INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN ENGINEERING Int. J. Numer. Meth. Engng (in press) Published online in Wiley InterScience (www.interscience.wiley.com). DOI: 10.1002/nme.1282 A FETI-DP method for the parallel iterative solution of indefinite and complex-valued solid and shell vibration problems Charbel Farhat1,∗,†, Jing Li2 and Philip Avery1 1Department of Mechanical Engineering and Institute for Computational and Mathematical Engineering, Stanford University, Building 500, Stanford, CA 94305-3035, U.S.A. 2Department of Mathematical Sciences, Kent State University, Kent, OH 44242, U.S.A. SUMMARY The dual-primal finite element tearing and interconnecting (FETI-DP) domain decomposition method (DDM) is extended to address the iterative solution of a class of indefinite problems of the form K − 2M u = f, and a class of complex problems of the form K − 2M + iD u = f, where K, M, and D are three real symmetric matrices arising from the finite element discretization of solid and shell dynamic problems, i is the imaginary complex number, and is a real positive number. A key component of this extension is a new coarse problem based on the free-space solutions of Navier’s equations of motion. These solutions are waves, and therefore the resulting DDM is reminiscent of the FETI-H method. For this reason, it is named here the FETI-DPH method. For a practically large range, FETI-DPH is shown numerically to be scalable with respect to all of the problem size, substructure size, and number of substructures. The CPU performance of this iterative solver is illustrated on a 40-processor computing system with the parallel solution, for various ranges, of several large-scale, indefinite, or complex-valued systems of equations associated with shifted eigenvalue and forced frequency response structural dynamics problems.
    [Show full text]
  • An Extension of the FETI Domain Decomposition Method for Incompressible and Nearly Incompressible Problems Benoit Vereecke, Henri Bavestrello, David Dureisseix
    An extension of the FETI domain decomposition method for incompressible and nearly incompressible problems Benoit Vereecke, Henri Bavestrello, David Dureisseix To cite this version: Benoit Vereecke, Henri Bavestrello, David Dureisseix. An extension of the FETI domain decomposi- tion method for incompressible and nearly incompressible problems. Computer Methods in Applied Mechanics and Engineering, Elsevier, 2003, 192 (31-32), pp.3409-3429. 10.1016/S0045-7825(03)00313- X. hal-00141163 HAL Id: hal-00141163 https://hal.archives-ouvertes.fr/hal-00141163 Submitted on 12 Apr 2007 HAL is a multi-disciplinary open access L’archive ouverte pluridisciplinaire HAL, est archive for the deposit and dissemination of sci- destinée au dépôt et à la diffusion de documents entific research documents, whether they are pub- scientifiques de niveau recherche, publiés ou non, lished or not. The documents may come from émanant des établissements d’enseignement et de teaching and research institutions in France or recherche français ou étrangers, des laboratoires abroad, or from public or private research centers. publics ou privés. An extension of the FETI domain decomposition method for incompressible and nearly incompressible problems B. Vereecke,∗ H. Bavestrello,† D. Dureisseix‡ Abstract Incompressible and nearly incompressible problems are treated herein with a mixed finite element formulation in order to avoid ill-conditioning that prevents accuracy in pressure estimation and lack of convergence for iterative solution algorithms. A multilevel dual domain decomposition method is then chosen as an iterative algorithm: the original FETI and FETI-DP methods are extended to deal with such problems, when the dis- cretization of the pressure field is discontinuous throughout the elements.
    [Show full text]