Capacitance Matrix Method

Size: px
Start display at page:

Download "Capacitance Matrix Method"

Transcription

1 Capacitance Matrix Method Marcus Sarkis New England Numerical Analysis Day at WPI, 2019 Thanks to Maksymilian Dryja, University of Warsaw 1

2 Outline 1 Timeline 2 Capacitance Matrix Method-CMM 3 Applications 4 Domain Imbedding 5 Proskurowski-Widlund 76 6 Domain Decomposition-Iterative Substructuring 7 Conclusion 2

3 Outline 1 Timeline 2 Capacitance Matrix Method-CMM 3 Applications 4 Domain Imbedding 5 Proskurowski-Widlund 76 6 Domain Decomposition-Iterative Substructuring 7 Conclusion 3

4 Timeline s In 1949, Sherman-Morrison-Woodbury identity (A + UDV T ) 1 = A 1 [A 1 U(D 1 + V T A 1 U) 1 V T A 1 ] In 1952, conjugated gradient method introduced by Hestenes-Stiefel In the 1960th years, there existed fast solvers for FD discretizations of some elliptic problems on rectangular regions based on FFT In 1968, the description of the CMM is credited to Oscar Buneman (see R. W. Hockney Formation and stability of virtual electrodes in a cylinder)

5 Timeline s Early 70 s: Buzbee, Dorr, George, Golub, Hockney, others In 1976, Proskurowski-Widlund, On the numerical solution of Helmholtz s equation by CMM Domain Imbedding: Shieh 1978 and 1979, O Leary-Widlund 1979, Proskurowski-Widlund 1980 (FEM), others Pierre-Louis Lions, Variational Alternating Schwarz Ficticius Component Method: Astrakhantsev 1978 and 1985, Matsokin and Skripko 1983, Matsokin and Nepomnyaschikh 1985 Domain Decomposition: Bjørstad-Widlund 1981 and 1986, Dryja 1982 and 1984, Dihn-Glowinski-Périaux 1985, others In 1982, Dryja, A capacitance matrix method for Dirichlet problem on polygon region

6 Timeline s In 1985, W. Hackbusch, Multi-Grid Methods and Applications In 1986, H. Yserentant, On the multilevel splitting of finite element spaces. In 1986, Bramble-Basciak-Schatz, The construction of precond. for elliptic problems by substructures I In January 1987, Paris, First International Symposium of Domain Decomposition Methods.

7 Capacitance Matrix Method-CMM 1 Timeline 2 Capacitance Matrix Method-CMM 3 Applications 4 Domain Imbedding 5 Proskurowski-Widlund 76 6 Domain Decomposition-Iterative Substructuring 7 Conclusion 7

8 CMM: B is a Fast Solver Let A R n n invertible matrix. Find the solution x of Ax = b Let B R n n invertible matrix which has the same rows as the matrix A, except the last p rows (in general p n) [ ] [ ] [ ] A11 A A = 12 b1 A11 A b = B = 12 A 21 A 22 b 2 B 21 B 22 See that Bx = [ b1 ] 8

9 CMM: Capacitance Matrix We look for solution of the form ˆb = [ b1 ˆb2 ] x = B 1ˆb + B 1 I np w p ˆb2 arbitrary where [ 0 I np = After some algebra, w p satisfies Cw p = g p where I pp ] C = I pp I T np(b A)B 1 I np and g p = b 2 ˆb 2 +I T np(b A)B 1ˆb or C = I T npab 1 I np and g p = b 2 I T npab 1ˆb C R p p is invertible and called the Capacitance Matrix 9

10 Implementations To find x, solve Cw p = g p and x = B 1ˆb + B 1 I np w p To solve Cw p = g p use a iterative method Each vector multiplication to C requires a B 1 fast solver Can build C by multiplying Ce i, 1 i p To build C: cost O(p n log 2 (n) Factorization of C: cost O(p 3 ) With an optimal preconditioner κ(p 1 C) = O(1) Cost O(n) log 2 (n) 10

11 Outline 1 Timeline 2 Capacitance Matrix Method-CMM 3 Applications 4 Domain Imbedding 5 Proskurowski-Widlund 76 6 Domain Decomposition-Iterative Substructuring 7 Conclusion 11

12 Applications Capacitance Matrix Method: Domain Imbedding-DI: After B FFT Domain Decomposition-Iterative Substructuring: After B localization

13 Outline 1 Timeline 2 Capacitance Matrix Method-CMM 3 Applications 4 Domain Imbedding 5 Proskurowski-Widlund 76 6 Domain Decomposition-Iterative Substructuring 7 Conclusion 13

14 Domain Imbedding-Dirichlet Problem: u = f on Ω and u = 0 on Ω Rectangular region R Ω and Ω a Ω Ω b = R\Ω a Γ = Ω a Ω b Finite Difference ( h x a = b a in Ω h a) ) and (x 2 = 0 on Γ h ) B aa 0 B a2 x a b a Ax = 0 B bb B b2 x b = 0 = b 0 0 I 22 x 2 0 FD ( h x = ˆb in R h ) and (zero Dirichlet on R) B aa 0 B a2 Ω h a B = 0 B bb B b2 Ω h b B 2a B 2b B 22 Γ h

15 Domain Imbedding-Dirichlet The capacitance matrix C = S 1 = (B 22 i={a,b} B 2i B 1 ii B i2 ) 1 C = I pp Inp(B T A)B 1 I np = InpAB T 1 I np Preconditioners κ(( p ) 1 2 C) = O(1). Dryja 1982 κ(h 1 S 1 H T ) = O(1 + log 2 h). Yserentant 1986

16 Domain Imbedding-Neumann u + cu = f in Ω and n u = 0 on Ω B aa 0 B a2 x a Ax = 0 B bb B b2 x b = B 2a 0 B (1) 22 x 2 Well conditioned Capacitance Matrix b a 0 0 = b C = S a (S) 1 = (B (a) 22 B 2a B 1 aa B a2 )(S) 1

17 Outline 1 Timeline 2 Capacitance Matrix Method-CMM 3 Applications 4 Domain Imbedding 5 Proskurowski-Widlund 76 6 Domain Decomposition-Iterative Substructuring 7 Conclusion 17

18 Proskurowski-Widlund, 1976 Modification of a rectangular domain R. W. Hocknew Five-points discretization of Laplace equation with a number of electrodes nodes are introduced in the interior of a rectangular region or on straight line segment to which one of several mesh points are assigned In Proskurowski-Widlund 76, the goal is to solve the Poisson problem in complex geometry (Dirichlet or Neumann problems) using FD. In Proskurowski-Widlund 76, the CMM is interpreted using classical potential theory using single-layer dipole (ansatz). And in this case C is SPD with condition number O(h) and CG is used

19 Proskurowski-Widlund 76 x = B 1ˆb + B 1 I np w p This equation is interpreted using the 76 paper notation u = Gf + GDµ G Discrete Green s Function Here µ is the dipole density (jump of normal derivatives) Cµ = (I p + Z T GD)µ = Z T Gf = g G is translated invariant (FFT techniques). To build C O(nlog 2 n + p 2 )

20 Outline 1 Timeline 2 Capacitance Matrix Method-CMM 3 Applications 4 Domain Imbedding 5 Proskurowski-Widlund 76 6 Domain Decomposition-Iterative Substructuring 7 Conclusion 20

21 L-Shaped Domain Poisson Equation on L-shaped region Ω = Ω a Γ Ω b Ω a = (0, x 1 ) (0, y 2 ) Γ = {x 1 } (0, y 1 ) Ω b = (x 1, x 2 ) (0, y 1 ) FDM with Homogeneous Dirichlet BC. Solve Ax = b [ ] [ A11 A A = 12 Ω h a Ω h b b1 b = A 21 A 22 Γ h b 2 ] We choose B of the form [ A11 A B = 12 0 I 22 ] C = A 22 A 21 A 1 11 A 12 = S, the Schur complement of A with respect to A 22

22 Remarks κ(c) = O(1/h) κ(( p ) 1 2 C) = O(1). Dryja 1982 If we choose C = I 22 B = [ A11 A 12 0 S ] 22

23 Sort of BDDC with Vertex Constraint Several substructures Ω i and interface Γ Ω = N i=1ω i Γ = Ω\( N i=1ω i ) Let V be the set of vertices of the substructures [ ] [ A11 A A = 12 (Ω h \Γ h ) V A11 A B = 12 A 21 A 22 Γ h \V 0 I 22 ] C = A 22 A 21 A 1 11 A 12 Preconditioner K = blockdiag{( ij ) 1 2 } Fij Γ 23

24 Neumann-Dirichlet Method Dryja, Proskurowski, Widlund, Checkerboard distribution local solvers. Or two subdomains Ω = Ω (D) Ω (N) = ( i ND Ω (D) i ) ( i NN Ω (N) i ) [ ] A11 A A = 12 A 21 A 22 Ω (D) h (interior) Ω (N) h B = v T 2 A 22 u 2 = a Ω (N)(u 2, v 2 ) + a Ω (D)(u 2, v 2 ) C = (A 22 A 21 A 1 11 A 12 )(A (N) 22 ) 1 κ(s(a (N) 22 ) 1 ) = O(1 + log H/h) 2 [ A11 A 12 0 A (N) 22 ] 24

25 Outline 1 Timeline 2 Capacitance Matrix Method-CMM 3 Applications 4 Domain Imbedding 5 Proskurowski-Widlund 76 6 Domain Decomposition-Iterative Substructuring 7 Conclusion 25

26 Conclusions THANK YOU 26

Multispace and Multilevel BDDC. Jan Mandel University of Colorado at Denver and Health Sciences Center

Multispace and Multilevel BDDC. Jan Mandel University of Colorado at Denver and Health Sciences Center Multispace and Multilevel BDDC Jan Mandel University of Colorado at Denver and Health Sciences Center Based on joint work with Bedřich Sousedík, UCDHSC and Czech Technical University, and Clark R. Dohrmann,

More information

ADDITIVE SCHWARZ FOR SCHUR COMPLEMENT 305 the parallel implementation of both preconditioners on distributed memory platforms, and compare their perfo

ADDITIVE SCHWARZ FOR SCHUR COMPLEMENT 305 the parallel implementation of both preconditioners on distributed memory platforms, and compare their perfo 35 Additive Schwarz for the Schur Complement Method Luiz M. Carvalho and Luc Giraud 1 Introduction Domain decomposition methods for solving elliptic boundary problems have been receiving increasing attention

More information

Multilevel and Adaptive Iterative Substructuring Methods. Jan Mandel University of Colorado Denver

Multilevel and Adaptive Iterative Substructuring Methods. Jan Mandel University of Colorado Denver Multilevel and Adaptive Iterative Substructuring Methods Jan Mandel University of Colorado Denver The multilevel BDDC method is joint work with Bedřich Sousedík, Czech Technical University, and Clark Dohrmann,

More information

AN INTRODUCTION TO DOMAIN DECOMPOSITION METHODS. Gérard MEURANT CEA

AN INTRODUCTION TO DOMAIN DECOMPOSITION METHODS. Gérard MEURANT CEA Marrakech Jan 2003 AN INTRODUCTION TO DOMAIN DECOMPOSITION METHODS Gérard MEURANT CEA Introduction Domain decomposition is a divide and conquer technique Natural framework to introduce parallelism in the

More information

An additive average Schwarz method for the plate bending problem

An additive average Schwarz method for the plate bending problem J. Numer. Math., Vol. 10, No. 2, pp. 109 125 (2002) c VSP 2002 Prepared using jnm.sty [Version: 02.02.2002 v1.2] An additive average Schwarz method for the plate bending problem X. Feng and T. Rahman Abstract

More information

Dirichlet-Neumann and Neumann-Neumann Methods

Dirichlet-Neumann and Neumann-Neumann Methods Dirichlet-Neumann and Neumann-Neumann Methods Felix Kwok Hong Kong Baptist University Introductory Domain Decomposition Short Course DD25, Memorial University of Newfoundland July 22, 2018 Outline Methods

More information

Numerical Solution I

Numerical Solution I Numerical Solution I Stationary Flow R. Kornhuber (FU Berlin) Summerschool Modelling of mass and energy transport in porous media with practical applications October 8-12, 2018 Schedule Classical Solutions

More information

Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions

Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions Bernhard Hientzsch Courant Institute of Mathematical Sciences, New York University, 51 Mercer Street, New

More information

A Balancing Algorithm for Mortar Methods

A Balancing Algorithm for Mortar Methods A Balancing Algorithm for Mortar Methods Dan Stefanica Baruch College, City University of New York, NY 11, USA Dan Stefanica@baruch.cuny.edu Summary. The balancing methods are hybrid nonoverlapping Schwarz

More information

Algebraic Coarse Spaces for Overlapping Schwarz Preconditioners

Algebraic Coarse Spaces for Overlapping Schwarz Preconditioners Algebraic Coarse Spaces for Overlapping Schwarz Preconditioners 17 th International Conference on Domain Decomposition Methods St. Wolfgang/Strobl, Austria July 3-7, 2006 Clark R. Dohrmann Sandia National

More information

A FETI-DP Method for Mortar Finite Element Discretization of a Fourth Order Problem

A FETI-DP Method for Mortar Finite Element Discretization of a Fourth Order Problem A FETI-DP Method for Mortar Finite Element Discretization of a Fourth Order Problem Leszek Marcinkowski 1 and Nina Dokeva 2 1 Department of Mathematics, Warsaw University, Banacha 2, 02 097 Warszawa, Poland,

More information

A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems

A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems Etereldes Gonçalves 1, Tarek P. Mathew 1, Markus Sarkis 1,2, and Christian E. Schaerer 1 1 Instituto de Matemática Pura

More information

From Direct to Iterative Substructuring: some Parallel Experiences in 2 and 3D

From Direct to Iterative Substructuring: some Parallel Experiences in 2 and 3D From Direct to Iterative Substructuring: some Parallel Experiences in 2 and 3D Luc Giraud N7-IRIT, Toulouse MUMPS Day October 24, 2006, ENS-INRIA, Lyon, France Outline 1 General Framework 2 The direct

More information

ASM-BDDC Preconditioners with variable polynomial degree for CG- and DG-SEM

ASM-BDDC Preconditioners with variable polynomial degree for CG- and DG-SEM ASM-BDDC Preconditioners with variable polynomial degree for CG- and DG-SEM C. Canuto 1, L. F. Pavarino 2, and A. B. Pieri 3 1 Introduction Discontinuous Galerkin (DG) methods for partial differential

More information

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis. Volume 11, pp. 1-24, 2000. Copyright 2000,. ISSN 1068-9613. ETNA NEUMANN NEUMANN METHODS FOR VECTOR FIELD PROBLEMS ANDREA TOSELLI Abstract. In this paper,

More information

The mortar element method for quasilinear elliptic boundary value problems

The mortar element method for quasilinear elliptic boundary value problems The mortar element method for quasilinear elliptic boundary value problems Leszek Marcinkowski 1 Abstract We consider a discretization of quasilinear elliptic boundary value problems by the mortar version

More information

SOME NONOVERLAPPING DOMAIN DECOMPOSITION METHODS

SOME NONOVERLAPPING DOMAIN DECOMPOSITION METHODS SIAM REV. c 1998 Society for Industrial and Applied Mathematics Vol. 40, No. 4, pp. 857 914, December 1998 004 SOME NONOVERLAPPING DOMAIN DECOMPOSITION METHODS JINCHAO XU AND JUN ZOU Abstract. The purpose

More information

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis. Volume 15, pp. 94-105, 2003. Copyright 2003,. ISSN 1068-9613. ETNA MULTILEVEL PRECONDITIONERS FOR LAGRANGE MULTIPLIERS IN DOMAIN IMBEDDING JANNE MARTIKAINEN,

More information

33 RASHO: A Restricted Additive Schwarz Preconditioner with Harmonic Overlap

33 RASHO: A Restricted Additive Schwarz Preconditioner with Harmonic Overlap Thirteenth International Conference on Domain Decomposition ethods Editors: N. Debit,.Garbey, R. Hoppe, J. Périaux, D. Keyes, Y. Kuznetsov c 001 DD.org 33 RASHO: A Restricted Additive Schwarz Preconditioner

More information

Indefinite and physics-based preconditioning

Indefinite and physics-based preconditioning Indefinite and physics-based preconditioning Jed Brown VAW, ETH Zürich 2009-01-29 Newton iteration Standard form of a nonlinear system F (u) 0 Iteration Solve: Update: J(ũ)u F (ũ) ũ + ũ + u Example (p-bratu)

More information

Substructuring for multiscale problems

Substructuring for multiscale problems Substructuring for multiscale problems Clemens Pechstein Johannes Kepler University Linz (A) jointly with Rob Scheichl Marcus Sarkis Clark Dohrmann DD 21, Rennes, June 2012 Outline 1 Introduction 2 Weighted

More information

Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms

Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms Marcus Sarkis Worcester Polytechnic Inst., Mass. and IMPA, Rio de Janeiro and Daniel

More information

XIAO-CHUAN CAI AND MAKSYMILIAN DRYJA. strongly elliptic equations discretized by the nite element methods.

XIAO-CHUAN CAI AND MAKSYMILIAN DRYJA. strongly elliptic equations discretized by the nite element methods. Contemporary Mathematics Volume 00, 0000 Domain Decomposition Methods for Monotone Nonlinear Elliptic Problems XIAO-CHUAN CAI AND MAKSYMILIAN DRYJA Abstract. In this paper, we study several overlapping

More information

Numerische Mathematik

Numerische Mathematik Numer. Math. (1996) 75: 59 77 Numerische Mathematik c Springer-Verlag 1996 Electronic Edition A preconditioner for the h-p version of the finite element method in two dimensions Benqi Guo 1, and Weiming

More information

A Nonoverlapping Subdomain Algorithm with Lagrange Multipliers and its Object Oriented Implementation for Interface Problems

A Nonoverlapping Subdomain Algorithm with Lagrange Multipliers and its Object Oriented Implementation for Interface Problems Contemporary Mathematics Volume 8, 998 B 0-88-0988--03030- A Nonoverlapping Subdomain Algorithm with Lagrange Multipliers and its Object Oriented Implementation for Interface Problems Daoqi Yang. Introduction

More information

Parallel scalability of a FETI DP mortar method for problems with discontinuous coefficients

Parallel scalability of a FETI DP mortar method for problems with discontinuous coefficients Parallel scalability of a FETI DP mortar method for problems with discontinuous coefficients Nina Dokeva and Wlodek Proskurowski University of Southern California, Department of Mathematics Los Angeles,

More information

Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions

Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions Ernst P. Stephan 1, Matthias Maischak 2, and Thanh Tran 3 1 Institut für Angewandte Mathematik, Leibniz

More information

OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative methods ffl Krylov subspace methods ffl Preconditioning techniques: Iterative methods ILU

OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative methods ffl Krylov subspace methods ffl Preconditioning techniques: Iterative methods ILU Preconditioning Techniques for Solving Large Sparse Linear Systems Arnold Reusken Institut für Geometrie und Praktische Mathematik RWTH-Aachen OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative

More information

Adaptive Coarse Space Selection in BDDC and FETI-DP Iterative Substructuring Methods: Towards Fast and Robust Solvers

Adaptive Coarse Space Selection in BDDC and FETI-DP Iterative Substructuring Methods: Towards Fast and Robust Solvers Adaptive Coarse Space Selection in BDDC and FETI-DP Iterative Substructuring Methods: Towards Fast and Robust Solvers Jan Mandel University of Colorado at Denver Bedřich Sousedík Czech Technical University

More information

A Balancing Algorithm for Mortar Methods

A Balancing Algorithm for Mortar Methods A Balancing Algorithm for Mortar Methods Dan Stefanica Baruch College, City University of New York, NY, USA. Dan_Stefanica@baruch.cuny.edu Summary. The balancing methods are hybrid nonoverlapping Schwarz

More information

Parallel Scalability of a FETI DP Mortar Method for Problems with Discontinuous Coefficients

Parallel Scalability of a FETI DP Mortar Method for Problems with Discontinuous Coefficients Parallel Scalability of a FETI DP Mortar Method for Problems with Discontinuous Coefficients Nina Dokeva and Wlodek Proskurowski Department of Mathematics, University of Southern California, Los Angeles,

More information

On a Fourier method of embedding domains using an optimal distributed control

On a Fourier method of embedding domains using an optimal distributed control Numerical Algorithms 3: 61 73, 003. 003 Kluwer Academic Publishers. Printed in the Netherlands. On a Fourier method of embedding domains using an optimal distributed control Lori Badea a and Prabir Daripa

More information

20. A Dual-Primal FETI Method for solving Stokes/Navier-Stokes Equations

20. A Dual-Primal FETI Method for solving Stokes/Navier-Stokes Equations Fourteenth International Conference on Domain Decomposition Methods Editors: Ismael Herrera, David E. Keyes, Olof B. Widlund, Robert Yates c 23 DDM.org 2. A Dual-Primal FEI Method for solving Stokes/Navier-Stokes

More information

Selecting Constraints in Dual-Primal FETI Methods for Elasticity in Three Dimensions

Selecting Constraints in Dual-Primal FETI Methods for Elasticity in Three Dimensions Selecting Constraints in Dual-Primal FETI Methods for Elasticity in Three Dimensions Axel Klawonn 1 and Olof B. Widlund 2 1 Universität Duisburg-Essen, Campus Essen, Fachbereich Mathematik, (http://www.uni-essen.de/ingmath/axel.klawonn/)

More information

On Hybrid Multigrid-Schwarz algorithms Sébastien Loisel, Reinhard Nabben, and Daniel B. Szyld Research Report August 2007

On Hybrid Multigrid-Schwarz algorithms Sébastien Loisel, Reinhard Nabben, and Daniel B. Szyld Research Report August 2007 On Hybrid Multigrid-Schwarz algorithms Sébastien Loisel, Reinhard Nabben, and Daniel B. Szyld Research Report 07-8-28 August 2007 This report is available in the World Wide Web at http://www.math.temple.edu/~szyld

More information

Parallel Galerkin Domain Decomposition Procedures for Parabolic Equation on General Domain

Parallel Galerkin Domain Decomposition Procedures for Parabolic Equation on General Domain Parallel Galerkin Domain Decomposition Procedures for Parabolic Equation on General Domain Keying Ma, 1 Tongjun Sun, 1 Danping Yang 1 School of Mathematics, Shandong University, Jinan 50100, People s Republic

More information

Dual-Primal Isogeometric Tearing and Interconnecting Solvers for Continuous and Discontinuous Galerkin IgA Equations

Dual-Primal Isogeometric Tearing and Interconnecting Solvers for Continuous and Discontinuous Galerkin IgA Equations Dual-Primal Isogeometric Tearing and Interconnecting Solvers for Continuous and Discontinuous Galerkin IgA Equations Christoph Hofer and Ulrich Langer Doctoral Program Computational Mathematics Numerical

More information

On the Use of Inexact Subdomain Solvers for BDDC Algorithms

On the Use of Inexact Subdomain Solvers for BDDC Algorithms On the Use of Inexact Subdomain Solvers for BDDC Algorithms Jing Li a, and Olof B. Widlund b,1 a Department of Mathematical Sciences, Kent State University, Kent, OH, 44242-0001 b Courant Institute of

More information

S MALASSOV The theory developed in this paper provides an approach which is applicable to second order elliptic boundary value problems with large ani

S MALASSOV The theory developed in this paper provides an approach which is applicable to second order elliptic boundary value problems with large ani SUBSTRUCTURNG DOMAN DECOMPOSTON METHOD FOR NONCONFORMNG FNTE ELEMENT APPROXMATONS OF ELLPTC PROBLEMS WTH ANSOTROPY SY MALASSOV y Abstract An optimal iterative method for solving systems of linear algebraic

More information

Some Domain Decomposition Methods for Discontinuous Coefficients

Some Domain Decomposition Methods for Discontinuous Coefficients Some Domain Decomposition Methods for Discontinuous Coefficients Marcus Sarkis WPI RICAM-Linz, October 31, 2011 Marcus Sarkis (WPI) Domain Decomposition Methods RICAM-2011 1 / 38 Outline Discretizations

More information

On the choice of abstract projection vectors for second level preconditioners

On the choice of abstract projection vectors for second level preconditioners On the choice of abstract projection vectors for second level preconditioners C. Vuik 1, J.M. Tang 1, and R. Nabben 2 1 Delft University of Technology 2 Technische Universität Berlin Institut für Mathematik

More information

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C.

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C. Lecture 9 Approximations of Laplace s Equation, Finite Element Method Mathématiques appliquées (MATH54-1) B. Dewals, C. Geuzaine V1.2 23/11/218 1 Learning objectives of this lecture Apply the finite difference

More information

Auxiliary space multigrid method for elliptic problems with highly varying coefficients

Auxiliary space multigrid method for elliptic problems with highly varying coefficients Auxiliary space multigrid method for elliptic problems with highly varying coefficients Johannes Kraus 1 and Maria Lymbery 2 1 Introduction The robust preconditioning of linear systems of algebraic equations

More information

A Fast Iterative Solver for Scattering by Elastic Objects in Layered Media

A Fast Iterative Solver for Scattering by Elastic Objects in Layered Media A Fast Iterative Solver for Scattering by Elastic Objects in Layered Media K. Ito and J. Toivanen Center for Research in Scientific Computation, North Carolina State University, Raleigh, North Carolina

More information

The All-floating BETI Method: Numerical Results

The All-floating BETI Method: Numerical Results The All-floating BETI Method: Numerical Results Günther Of Institute of Computational Mathematics, Graz University of Technology, Steyrergasse 30, A-8010 Graz, Austria, of@tugraz.at Summary. The all-floating

More information

16. Finite Difference Method with Fictitious Domain Applied to a Dirichlet Problem

16. Finite Difference Method with Fictitious Domain Applied to a Dirichlet Problem 12th International Conference on Domain Decomposition Methods Editors: Tony Chan, Takashi Kako, Hideo Kawarada, Olivier Pironneau, c 2001 DDM.org 16. Finite Difference Method with Fictitious Domain Applied

More information

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends Lecture 3: Finite Elements in 2-D Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Finite Element Methods 1 / 18 Outline 1 Boundary

More information

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis. Volume 31, pp. 384-402, 2008. Copyright 2008,. ISSN 1068-9613. ETNA ON THE EQUIVALENCE OF PRIMAL AND DUAL SUBSTRUCTURING PRECONDITIONERS BEDŘICH SOUSEDÍK

More information

Preconditioning of Saddle Point Systems by Substructuring and a Penalty Approach

Preconditioning of Saddle Point Systems by Substructuring and a Penalty Approach Preconditioning of Saddle Point Systems by Substructuring and a Penalty Approach Clark R. Dohrmann 1 Sandia National Laboratories, crdohrm@sandia.gov. Sandia is a multiprogram laboratory operated by Sandia

More information

Convergence Behavior of a Two-Level Optimized Schwarz Preconditioner

Convergence Behavior of a Two-Level Optimized Schwarz Preconditioner Convergence Behavior of a Two-Level Optimized Schwarz Preconditioner Olivier Dubois 1 and Martin J. Gander 2 1 IMA, University of Minnesota, 207 Church St. SE, Minneapolis, MN 55455 dubois@ima.umn.edu

More information

Master Thesis Literature Study Presentation

Master Thesis Literature Study Presentation Master Thesis Literature Study Presentation Delft University of Technology The Faculty of Electrical Engineering, Mathematics and Computer Science January 29, 2010 Plaxis Introduction Plaxis Finite Element

More information

Preconditioning Techniques Analysis for CG Method

Preconditioning Techniques Analysis for CG Method Preconditioning Techniques Analysis for CG Method Huaguang Song Department of Computer Science University of California, Davis hso@ucdavis.edu Abstract Matrix computation issue for solve linear system

More information

Parallel Sums and Adaptive BDDC Deluxe

Parallel Sums and Adaptive BDDC Deluxe 249 Parallel Sums and Adaptive BDDC Deluxe Olof B. Widlund 1 and Juan G. Calvo 2 1 Introduction There has recently been a considerable activity in developing adaptive methods for the selection of primal

More information

INSTITUTE OF MATHEMATICS THE CZECH ACADEMY OF SCIENCES. A virtual overlapping Schwarz method for scalar elliptic problems in two dimensions

INSTITUTE OF MATHEMATICS THE CZECH ACADEMY OF SCIENCES. A virtual overlapping Schwarz method for scalar elliptic problems in two dimensions INSTITUTE OF MATHEMATICS THE CZECH ACADEMY OF SCIENCES A virtual overlapping Schwarz method for scalar elliptic problems in two dimensions Juan Gabriel Calvo Preprint No. 25-2017 PRAHA 2017 A VIRTUAL

More information

Extending the theory for domain decomposition algorithms to less regular subdomains

Extending the theory for domain decomposition algorithms to less regular subdomains Extending the theory for domain decomposition algorithms to less regular subdomains Olof Widlund Courant Institute of Mathematical Sciences New York University http://www.cs.nyu.edu/cs/faculty/widlund/

More information

Multilevel low-rank approximation preconditioners Yousef Saad Department of Computer Science and Engineering University of Minnesota

Multilevel low-rank approximation preconditioners Yousef Saad Department of Computer Science and Engineering University of Minnesota Multilevel low-rank approximation preconditioners Yousef Saad Department of Computer Science and Engineering University of Minnesota SIAM CSE Boston - March 1, 2013 First: Joint work with Ruipeng Li Work

More information

A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS

A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS Proceedings of ALGORITMY 2005 pp. 222 229 A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS ELENA BRAVERMAN, MOSHE ISRAELI, AND ALEXANDER SHERMAN Abstract. Based on a fast subtractional

More information

Optimal multilevel preconditioning of strongly anisotropic problems.part II: non-conforming FEM. p. 1/36

Optimal multilevel preconditioning of strongly anisotropic problems.part II: non-conforming FEM. p. 1/36 Optimal multilevel preconditioning of strongly anisotropic problems. Part II: non-conforming FEM. Svetozar Margenov margenov@parallel.bas.bg Institute for Parallel Processing, Bulgarian Academy of Sciences,

More information

Lecture 18 Classical Iterative Methods

Lecture 18 Classical Iterative Methods Lecture 18 Classical Iterative Methods MIT 18.335J / 6.337J Introduction to Numerical Methods Per-Olof Persson November 14, 2006 1 Iterative Methods for Linear Systems Direct methods for solving Ax = b,

More information

OVERLAPPING SCHWARZ ALGORITHMS FOR ALMOST INCOMPRESSIBLE LINEAR ELASTICITY TR

OVERLAPPING SCHWARZ ALGORITHMS FOR ALMOST INCOMPRESSIBLE LINEAR ELASTICITY TR OVERLAPPING SCHWARZ ALGORITHMS FOR ALMOST INCOMPRESSIBLE LINEAR ELASTICITY MINGCHAO CAI, LUCA F. PAVARINO, AND OLOF B. WIDLUND TR2014-969 Abstract. Low order finite element discretizations of the linear

More information

PARTITION OF UNITY FOR THE STOKES PROBLEM ON NONMATCHING GRIDS

PARTITION OF UNITY FOR THE STOKES PROBLEM ON NONMATCHING GRIDS PARTITION OF UNITY FOR THE STOES PROBLEM ON NONMATCHING GRIDS CONSTANTIN BACUTA AND JINCHAO XU Abstract. We consider the Stokes Problem on a plane polygonal domain Ω R 2. We propose a finite element method

More information

On solving linear systems arising from Shishkin mesh discretizations

On solving linear systems arising from Shishkin mesh discretizations On solving linear systems arising from Shishkin mesh discretizations Petr Tichý Faculty of Mathematics and Physics, Charles University joint work with Carlos Echeverría, Jörg Liesen, and Daniel Szyld October

More information

Optimal Interface Conditions for an Arbitrary Decomposition into Subdomains

Optimal Interface Conditions for an Arbitrary Decomposition into Subdomains Optimal Interface Conditions for an Arbitrary Decomposition into Subdomains Martin J. Gander and Felix Kwok Section de mathématiques, Université de Genève, Geneva CH-1211, Switzerland, Martin.Gander@unige.ch;

More information

Scalable Domain Decomposition Preconditioners For Heterogeneous Elliptic Problems

Scalable Domain Decomposition Preconditioners For Heterogeneous Elliptic Problems Scalable Domain Decomposition Preconditioners For Heterogeneous Elliptic Problems Pierre Jolivet, F. Hecht, F. Nataf, C. Prud homme Laboratoire Jacques-Louis Lions Laboratoire Jean Kuntzmann INRIA Rocquencourt

More information

From the Boundary Element Domain Decomposition Methods to Local Trefftz Finite Element Methods on Polyhedral Meshes

From the Boundary Element Domain Decomposition Methods to Local Trefftz Finite Element Methods on Polyhedral Meshes From the Boundary Element Domain Decomposition Methods to Local Trefftz Finite Element Methods on Polyhedral Meshes Dylan Copeland 1, Ulrich Langer 2, and David Pusch 3 1 Institute of Computational Mathematics,

More information

Short title: Total FETI. Corresponding author: Zdenek Dostal, VŠB-Technical University of Ostrava, 17 listopadu 15, CZ Ostrava, Czech Republic

Short title: Total FETI. Corresponding author: Zdenek Dostal, VŠB-Technical University of Ostrava, 17 listopadu 15, CZ Ostrava, Czech Republic Short title: Total FETI Corresponding author: Zdenek Dostal, VŠB-Technical University of Ostrava, 17 listopadu 15, CZ-70833 Ostrava, Czech Republic mail: zdenek.dostal@vsb.cz fax +420 596 919 597 phone

More information

Jae Heon Yun and Yu Du Han

Jae Heon Yun and Yu Du Han Bull. Korean Math. Soc. 39 (2002), No. 3, pp. 495 509 MODIFIED INCOMPLETE CHOLESKY FACTORIZATION PRECONDITIONERS FOR A SYMMETRIC POSITIVE DEFINITE MATRIX Jae Heon Yun and Yu Du Han Abstract. We propose

More information

Preface to the Second Edition. Preface to the First Edition

Preface to the Second Edition. Preface to the First Edition n page v Preface to the Second Edition Preface to the First Edition xiii xvii 1 Background in Linear Algebra 1 1.1 Matrices................................. 1 1.2 Square Matrices and Eigenvalues....................

More information

On deflation and singular symmetric positive semi-definite matrices

On deflation and singular symmetric positive semi-definite matrices Journal of Computational and Applied Mathematics 206 (2007) 603 614 www.elsevier.com/locate/cam On deflation and singular symmetric positive semi-definite matrices J.M. Tang, C. Vuik Faculty of Electrical

More information

From the Boundary Element DDM to local Trefftz Finite Element Methods on Polyhedral Meshes

From the Boundary Element DDM to local Trefftz Finite Element Methods on Polyhedral Meshes www.oeaw.ac.at From the Boundary Element DDM to local Trefftz Finite Element Methods on Polyhedral Meshes D. Copeland, U. Langer, D. Pusch RICAM-Report 2008-10 www.ricam.oeaw.ac.at From the Boundary Element

More information

Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses

Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses P. Boyanova 1, I. Georgiev 34, S. Margenov, L. Zikatanov 5 1 Uppsala University, Box 337, 751 05 Uppsala,

More information

1. Fast Solvers and Schwarz Preconditioners for Spectral Nédélec Elements for a Model Problem in H(curl)

1. Fast Solvers and Schwarz Preconditioners for Spectral Nédélec Elements for a Model Problem in H(curl) DDM Preprint Editors: editor1, editor2, editor3, editor4 c DDM.org 1. Fast Solvers and Schwarz Preconditioners for Spectral Nédélec Elements for a Model Problem in H(curl) Bernhard Hientzsch 1 1. Introduction.

More information

Finite Difference Methods for Boundary Value Problems

Finite Difference Methods for Boundary Value Problems Finite Difference Methods for Boundary Value Problems October 2, 2013 () Finite Differences October 2, 2013 1 / 52 Goals Learn steps to approximate BVPs using the Finite Difference Method Start with two-point

More information

Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems

Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems Stan Tomov Innovative Computing Laboratory Computer Science Department The University of Tennessee Wednesday April 4,

More information

Higher-Order Compact Finite Element Method

Higher-Order Compact Finite Element Method Higher-Order Compact Finite Element Method Major Qualifying Project Advisor: Professor Marcus Sarkis Amorn Chokchaisiripakdee Worcester Polytechnic Institute Abstract The Finite Element Method (FEM) is

More information

Explicit Jump Immersed Interface Method: Documentation for 2D Poisson Code

Explicit Jump Immersed Interface Method: Documentation for 2D Poisson Code Eplicit Jump Immersed Interface Method: Documentation for 2D Poisson Code V. Rutka A. Wiegmann November 25, 2005 Abstract The Eplicit Jump Immersed Interface method is a powerful tool to solve elliptic

More information

Two new enriched multiscale coarse spaces for the Additive Average Schwarz method

Two new enriched multiscale coarse spaces for the Additive Average Schwarz method 346 Two new enriched multiscale coarse spaces for the Additive Average Schwarz method Leszek Marcinkowski 1 and Talal Rahman 2 1 Introduction We propose additive Schwarz methods with spectrally enriched

More information

ON THE CONVERGENCE OF A DUAL-PRIMAL SUBSTRUCTURING METHOD. January 2000

ON THE CONVERGENCE OF A DUAL-PRIMAL SUBSTRUCTURING METHOD. January 2000 ON THE CONVERGENCE OF A DUAL-PRIMAL SUBSTRUCTURING METHOD JAN MANDEL AND RADEK TEZAUR January 2000 Abstract In the Dual-Primal FETI method, introduced by Farhat et al [5], the domain is decomposed into

More information

SOLVING ELLIPTIC PDES

SOLVING ELLIPTIC PDES university-logo SOLVING ELLIPTIC PDES School of Mathematics Semester 1 2008 OUTLINE 1 REVIEW 2 POISSON S EQUATION Equation and Boundary Conditions Solving the Model Problem 3 THE LINEAR ALGEBRA PROBLEM

More information

Coupled FETI/BETI for Nonlinear Potential Problems

Coupled FETI/BETI for Nonlinear Potential Problems Coupled FETI/BETI for Nonlinear Potential Problems U. Langer 1 C. Pechstein 1 A. Pohoaţǎ 1 1 Institute of Computational Mathematics Johannes Kepler University Linz {ulanger,pechstein,pohoata}@numa.uni-linz.ac.at

More information

Fast Iterative Solution of Saddle Point Problems

Fast Iterative Solution of Saddle Point Problems Michele Benzi Department of Mathematics and Computer Science Emory University Atlanta, GA Acknowledgments NSF (Computational Mathematics) Maxim Olshanskii (Mech-Math, Moscow State U.) Zhen Wang (PhD student,

More information

Domain Decomposition Methods for Mortar Finite Elements

Domain Decomposition Methods for Mortar Finite Elements Domain Decomposition Methods for Mortar Finite Elements Dan Stefanica Courant Institute of Mathematical Sciences New York University September 1999 A dissertation in the Department of Mathematics Submitted

More information

Universität Stuttgart

Universität Stuttgart Universität Stuttgart Multilevel Additive Schwarz Preconditioner For Nonconforming Mortar Finite Element Methods Masymilian Dryja, Andreas Gantner, Olof B. Widlund, Barbara I. Wohlmuth Berichte aus dem

More information

Domain Decomposition, Operator Trigonometry, Robin Condition

Domain Decomposition, Operator Trigonometry, Robin Condition Contemporary Mathematics Volume 218, 1998 B 0-8218-0988-1-03039-9 Domain Decomposition, Operator Trigonometry, Robin Condition Karl Gustafson 1. Introduction The purpose of this paper is to bring to the

More information

Incomplete Cholesky preconditioners that exploit the low-rank property

Incomplete Cholesky preconditioners that exploit the low-rank property anapov@ulb.ac.be ; http://homepages.ulb.ac.be/ anapov/ 1 / 35 Incomplete Cholesky preconditioners that exploit the low-rank property (theory and practice) Artem Napov Service de Métrologie Nucléaire, Université

More information

Overlapping Schwarz Preconditioners for Spectral. Problem in H(curl)

Overlapping Schwarz Preconditioners for Spectral. Problem in H(curl) Overlapping Schwarz Preconditioners for Spectral Nédélec Elements for a Model Problem in H(curl) Technical Report TR2002-83 November 22, 2002 Department of Computer Science Courant Institute of Mathematical

More information

DOMAIN DECOMPOSITION FOR LESS REGULAR SUBDOMAINS: OVERLAPPING SCHWARZ IN TWO DIMENSIONS TR

DOMAIN DECOMPOSITION FOR LESS REGULAR SUBDOMAINS: OVERLAPPING SCHWARZ IN TWO DIMENSIONS TR DOMAIN DECOMPOSITION FOR LESS REGULAR SUBDOMAINS: OVERLAPPING SCHWARZ IN TWO DIMENSIONS TR2007-888 CLARK R. DOHRMANN, AXEL KLAWONN, AND OLOF B. WIDLUND Abstract. In the theory of domain decomposition methods,

More information

for three dimensional problems are often more complicated than the quite simple constructions that work well for problems in the plane; see [23] for a

for three dimensional problems are often more complicated than the quite simple constructions that work well for problems in the plane; see [23] for a DUAL-PRIMAL FETI METHODS FOR THREE-DIMENSIONAL ELLIPTIC PROBLEMS WITH HETEROGENEOUS COEFFICIENTS AEL KLAWONN Λ, OLOF B. WIDLUND y, AND MAKSYMILIAN DRYJA z Abstract. In this paper, certain iterative substructuring

More information

Construction of a New Domain Decomposition Method for the Stokes Equations

Construction of a New Domain Decomposition Method for the Stokes Equations Construction of a New Domain Decomposition Method for the Stokes Equations Frédéric Nataf 1 and Gerd Rapin 2 1 CMAP, CNRS; UMR7641, Ecole Polytechnique, 91128 Palaiseau Cedex, France 2 Math. Dep., NAM,

More information

Multispace and Multilevel BDDC

Multispace and Multilevel BDDC Multispace and Multilevel BDDC Jan Mandel Bedřich Sousedík Clark R. Dohrmann February 11, 2018 arxiv:0712.3977v2 [math.na] 21 Jan 2008 Abstract BDDC method is the most advanced method from the Balancing

More information

Inexact Data-Sparse BETI Methods by Ulrich Langer. (joint talk with G. Of, O. Steinbach and W. Zulehner)

Inexact Data-Sparse BETI Methods by Ulrich Langer. (joint talk with G. Of, O. Steinbach and W. Zulehner) Inexact Data-Sparse BETI Methods by Ulrich Langer (joint talk with G. Of, O. Steinbach and W. Zulehner) Radon Institute for Computational and Applied Mathematics Austrian Academy of Sciences http://www.ricam.oeaw.ac.at

More information

Preconditioned CG-Solvers and Finite Element Grids

Preconditioned CG-Solvers and Finite Element Grids Preconditioned CG-Solvers and Finite Element Grids R. Bauer and S. Selberherr Institute for Microelectronics, Technical University of Vienna Gusshausstrasse 27-29, A-1040 Vienna, Austria Phone +43/1/58801-3854,

More information

CONVERGENCE ANALYSIS OF A BALANCING DOMAIN DECOMPOSITION METHOD FOR SOLVING A CLASS OF INDEFINITE LINEAR SYSTEMS

CONVERGENCE ANALYSIS OF A BALANCING DOMAIN DECOMPOSITION METHOD FOR SOLVING A CLASS OF INDEFINITE LINEAR SYSTEMS CONVERGENCE ANALYSIS OF A BALANCING DOMAIN DECOMPOSITION METHOD FOR SOLVING A CLASS OF INDEFINITE LINEAR SYSTEMS JING LI AND XUEMIN TU Abstract A variant of balancing domain decomposition method by constraints

More information

On the Numerical Solution of Helmholtz's Equation by the Capacitance Matrix Method

On the Numerical Solution of Helmholtz's Equation by the Capacitance Matrix Method MATHEMATICS OF COMPUTATION, VOLUME 3, NUMBER 35 JULY 976, PAGES 433-468 On the Numerical Solution of Helmholtz's Equation by the Capacitance Matrix Method By Wlodzimierz Proskurowski and Olof Widlund*

More information

ADI iterations for. general elliptic problems. John Strain Mathematics Department UC Berkeley July 2013

ADI iterations for. general elliptic problems. John Strain Mathematics Department UC Berkeley July 2013 ADI iterations for general elliptic problems John Strain Mathematics Department UC Berkeley July 2013 1 OVERVIEW Classical alternating direction implicit (ADI) iteration Essentially optimal in simple domains

More information

Numerische Mathematik

Numerische Mathematik umer. Math. 73: 149 167 (1996) umerische Mathematik c Springer-Verlag 1996 Overlapping Schwarz methods on unstructured meshes using non-matching coarse grids Tony F. Chan 1, Barry F. Smith 2, Jun Zou 3

More information

Nonoverlapping Domain Decomposition Methods with Simplified Coarse Spaces for Solving Three-dimensional Elliptic Problems

Nonoverlapping Domain Decomposition Methods with Simplified Coarse Spaces for Solving Three-dimensional Elliptic Problems Nonoverlapping Domain Decomposition Methods with Simplified Coarse Spaces for Solving Three-dimensional Elliptic Problems Qiya Hu 1, Shi Shu 2 and Junxian Wang 3 Abstract In this paper we propose a substructuring

More information

Some examples in domain decomposition

Some examples in domain decomposition Some examples in domain decomposition Frédéric Nataf nataf@ann.jussieu.fr, www.ann.jussieu.fr/ nataf Laboratoire J.L. Lions, CNRS UMR7598. Université Pierre et Marie Curie, France Joint work with V. Dolean

More information

Nonparametric density estimation for elliptic problems with random perturbations

Nonparametric density estimation for elliptic problems with random perturbations Nonparametric density estimation for elliptic problems with random perturbations, DqF Workshop, Stockholm, Sweden, 28--2 p. /2 Nonparametric density estimation for elliptic problems with random perturbations

More information

Total Overlapping Schwarz Preconditioners for Elliptic PDEs ( a ) ( b )

Total Overlapping Schwarz Preconditioners for Elliptic PDEs ( a ) ( b ) 1 Seminaire, PARIS XIII, 05/12/08 Total Overlapping Schwarz Preconditioners for Elliptic PDEs ( a ) ( b ) F. Ben Belgacem (LMAC-UTCompiègne) N. Gmati (LAMSIN-ENITunis) F. Jelassi (LMAC-UTCompiègne) a Main

More information