Toward black-box adaptive domain decomposition methods

Size: px
Start display at page:

Download "Toward black-box adaptive domain decomposition methods"

Transcription

1 Toward black-box adaptive domain decomposition methods Frédéric Nataf Laboratory J.L. Lions (LJLL), CNRS, Alpines Inria and Univ. Paris VI joint work with Victorita Dolean (Univ. Nice Sophia-Antipolis) Patrice Hauret (Michelin, Clermont-Ferrand) Frédéric Hecht (LJLL) Pierre Jolivet (LJLL) Clemens Pechstein (Johannes Kepler Univ., Linz) Robert Scheichl (Univ. Bath) Nicole Spillane (LJLL) JLPC Lyon 2013

2 Outline 1 Some Applications 2 An abstract 2-level Schwarz: the GenEO algorithm 3 Conclusion F. Nataf et al BB DDM 2 / 28

3 Outline 1 Some Applications 2 An abstract 2-level Schwarz: the GenEO algorithm 3 Conclusion F. Nataf et al BB DDM 3 / 28

4 Motivation Large Sparse discretized system with strongly heterogeneous coefficients (high contrast, nonlinear, multiscale) E.g. Darcy pressure equation, P 1 -finite elements: Applications: flow in heterogeneous / stochastic / layered media structural mechanics time dependent waves etc. AU = F cond(a) α max α min h 2 Goal: iterative solvers robust in size and heterogeneities F. Nataf et al BB DDM 4 / 28

5 Problem div(σ(u)) = f, where ( ) σ ij (u) = 2µε ij (u) + λδ ij div(u), ε ij (u) = 1 ui 2 x j + u j x i, f = (0, g) T = (0, 10) T, µ = E 2(1+ν), λ = Eν (1+ν)(1 2ν). After a FEM (fintie element method) discretization: AU = F where A is a large sparse highy heterogeneous matrix. F. Nataf et al BB DDM 5 / 28

6 Black box solvers (solve(mat,rhs,sol)) Direct Solvers Iterative Solvers Pros Robustness Naturally Cons Difficult to Robustness Domain Decomposition Methods (DDM): Hybrid solver should be naturally parallel and robust General form: Au = f, solved with PCG for a preconditioner M 1. What s classical: Robustness with respect to problem size (scalability) What s New here: Provable Robustness in the SPD case with respect to: Coefficients jumps System of PDEs F. Nataf et al BB DDM 6 / 28

7 Black box solvers (solve(mat,rhs,sol)) Direct Solvers Iterative Solvers Pros Robustness Naturally Cons Difficult to Robustness Domain Decomposition Methods (DDM): Hybrid solver should be naturally parallel and robust General form: Au = f, solved with PCG for a preconditioner M 1. What s classical: Robustness with respect to problem size (scalability) What s New here: Provable Robustness in the SPD case with respect to: Coefficients jumps System of PDEs F. Nataf et al BB DDM 6 / 28

8 The First Domain Decomposition Method The original Schwarz Method (H.A. Schwarz, 1870) (u) = f in Ω u = 0 on Ω. Ω 1 Ω 2 Schwarz Method : (u1 n, un 2 ) (un+1 1, u n+1 2 ) with (u n+1 1 ) = f in Ω 1 u n+1 1 = 0 on Ω 1 Ω u n+1 1 = u2 n on Ω 1 Ω 2. (u n+1 2 ) = f in Ω 2 u n+1 2 = 0 on Ω 2 Ω u n+1 2 = u n+1 1 on Ω 2 Ω 1. Parallel algorithm, converges but very slowly, overlapping subdomains only. The parallel version is called Jacobi Schwarz method (JSM). F. Nataf et al BB DDM 7 / 28

9 Jacobi and Schwarz (I): Algebraic point of view The set of indices is partitioned into two sets N 1 and N 2 : ( ) ( ) ( ) A11 A 12 x1 b1 = A 21 A 22 x 2 b 2 The block-jacobi algorithm reads: ( ) ( ) ( A11 0 x k A12 0 A 22 x k+1 = A ) ( x k 1 x k 2 ) ( b1 + b 2 It corresponds to solving a Dirichlet boundary value problem in each subdomain with Dirichlet data taken from the other one at the previous step Schwarz method with minimal overlap 1 2 ) 1 2 Figure : Domain decomposition with minimal overlap F. Nataf et al BB DDM 8 / 28

10 Jacobi and Schwarz (II): Larger overlap Let δ be a non negative integer 1 2 n s n s + δ Figure : Domain decomposition with overlap A = n s ( ) or n s + δ ( ) n s + 1 n s Figure : Matrix decomposition Without or with overlap F. Nataf et al BB DDM 9 / 28

11 Strong and Weak scalability How to evaluate the efficiency of a domain decomposition? Strong scalability (Amdahl) How the solution time varies with the number of processors for a fixed total problem size Weak scalability (Gustafson) How the solution time varies with the number of processors for a fixed problem size per processor. Not achieved with the one level method Number of subdomains ASM The iteration number increases linearly with the number of subdomains in one direction. F. Nataf et al BB DDM 10 / 28

12 How to achieve scalability Stagnation corresponds to a few very low eigenvalues in the spectrum of the preconditioned problem. They are due to the lack of a global exchange of information in the preconditioner. u = f in Ω u = 0 on Ω The mean value of the solution in domain i depends on the value of f on all subdomains. A classical remedy consists in the introduction of a coarse problem that couples all subdomains. This is closely related to deflation technique classical in linear algebra (see Nabben and Vuik s papers in SIAM J. Sci. Comp, 200X) and multigrid techniques. F. Nataf et al BB DDM 11 / 28

13 Adding a coarse space We add a coarse space correction (aka second level) Let V H be the coarse space and Z be a basis, V H = span Z, writing R 0 = Z T we define the two level preconditioner as: M 1 ASM,2 := RT 0 (R 0AR T 0 ) 1 R 0 + N i=1 R T i A 1 i R i. The Nicolaides approach is to use the kernel of the operator as a coarse space, this is the constant vectors, in local form this writes: Z := (Ri T D i R i 1) 1 i N where D i are chosen so that we have a partition of unity: N Ri T D i R i = Id. i=1 F. Nataf et al BB DDM 12 / 28

14 Theoretical convergence result Theorem (Widlund, Dryija) Let M 1 ASM,2 be the two-level additive Schwarz method: κ(m 1 ASM,2 (1 A) C + H ) δ where δ is the size of the overlap between the subdomains and H the subdomain size. This does indeed work very well Number of subdomains ASM ASM + Nicolaides F. Nataf et al BB DDM 13 / 28

15 Failure for Darcy equation with heterogeneities (α(x, y) u) = 0 in Ω R 2, u = 0 on Ω D, u n = 0 on Ω N. IsoValue Our approach Decomposition α(x, y) Jump ASM ASM + Nicolaides Fix the problem by an optimal and proven choice of a coarse space Z. F. Nataf et al BB DDM 14 / 28

16 Outline 1 Some Applications 2 An abstract 2-level Schwarz: the GenEO algorithm Choice of the coarse space Parallel implementation 3 Conclusion F. Nataf et al BB DDM 15 / 28

17 Objectives Strategy Define an appropriate coarse space V H 2 = span(z 2 ) and use the framework previously introduced, writing R 0 = Z2 T the two level preconditioner is: P 1 ASM 2 := RT 0 (R 0AR T 0 ) 1 R 0 + N i=1 R T i A 1 i R i. The coarse space must be Local (calculated on each subdomain) parallel Adaptive (calculated automatically) Easy and cheap to compute Robust (must lead to an algorithm whose convergence is proven not to depend on the partition nor the jumps in coefficients) F. Nataf et al BB DDM 16 / 28

18 Abstract eigenvalue problem Gen.EVP per subdomain: Find p j,k V h Ωj and λ j,k 0: a Ωj (p j,k, v) = λ j,k a Ω j (Ξ j p j,k, Ξ j v) v V h Ωj A j p j,k = λ j,k X j A j X j p j,k (X j... diagonal) a D... restriction of a to D In the two-level ASM: Choose first m j eigenvectors per subdomain: V 0 = span { Ξ j p j,k } j=1,...,n k=1,...,m j This automatically includes Zero Energy Modes. F. Nataf et al BB DDM 17 / 28

19 Abstract eigenvalue problem Gen.EVP per subdomain: Find p j,k V h Ωj and λ j,k 0: a Ωj (p j,k, v) = λ j,k a Ω j (Ξ j p j,k, Ξ j v) v V h Ωj A j p j,k = λ j,k X j A j X j p j,k (X j... diagonal) a D... restriction of a to D In the two-level ASM: Choose first m j eigenvectors per subdomain: V 0 = span { Ξ j p j,k } j=1,...,n k=1,...,m j This automatically includes Zero Energy Modes. F. Nataf et al BB DDM 17 / 28

20 Comparison with existing works Galvis & Efendiev (SIAM 2010): κ p j,k v dx = λ j,k κ p j,k v dx Ω j Ω j v V h Ωj Efendiev, Galvis, Lazarov & Willems (submitted): a Ωj (p j,k, v) = λ j,k a Ωj (ξ j ξ i p j,k, ξ j ξ i v) v V Ωj Our gen.evp: i neighb(j) ξ j... partition of unity, calculated adaptively (MS) a Ωj (p j,k, v) = λ j,k a Ω j (Ξ j p j,k, Ξ j v) v V h Ωj both matrices typically singular = λ j,k [0, ] F. Nataf et al BB DDM 18 / 28

21 Theory Two technical assumptions. Theorem (Spillane, Dolean, Hauret, N., Pechstein, Scheichl) If for all j: 0 < λ j,mj+1 < : [ κ(m 1 ASM,2 A) (1 + k 0) 2 + k 0 (2k 0 + 1) N max j=1 ( )] λ j,mj +1 Possible criterion for picking m j : (used in our Numerics) λ j,mj +1 < δ j H j H j... subdomain diameter, δ j... overlap F. Nataf et al BB DDM 19 / 28

22 E Eigenvalues and eigenvectors Eigenvector number 1 is e-15; exageration coefficient is: Eigenvector number 2 is e-16; exageration coefficient is: Eigenvector number 3 is e-15; exageration coefficient is: Eigenvector number 4 is e-05; exageration coefficient is: Eigenvector number 5 is e-05; exageration coefficient is: Eigenvector number 6 is e-05; exageration coefficient is: Eigenvector number 7 is ; exageration coefficient is: Eigenvector number 8 is ; exageration coefficient is: Eigenvector number 9 is ; exageration coefficient is: Eigenvector number 10 is ; exageration coefficient is: Eigenvector number 11 is ; exageration coefficient is: Eigenvector number 12 is ; exageration coefficient is: Eigenvector number 13 is ; exageration coefficient is: Eigenvector number 14 is ; exageration coefficient is: Eigenvector number 15 is ; exageration coefficient is: eigenvalue (log scale) eigenvalue number Logarithmic scale F. Nataf et al BB DDM 20 / 28

23 Convergence AS P BNN : AS + Z Nico P BNN : AS + Z D2N GMRES P BNN : AS + Z D2N Error Iteration count F. Nataf et al BB DDM 21 / 28

24 Numerical results via a Domain Specific Language FreeFem++ ( with: Metis Karypis and Kumar 1998 SCOTCH Chevalier and Pellegrini 2008 UMFPACK Davis 2004 ARPACK Lehoucq et al MPI Snir et al Intel MKL PARDISO Schenk et al MUMPS Amestoy et al PaStiX Hénon et al PETSC Why use a DS(E)L instead of C/C++/Fortran/..? performances close to low-level language implementation, hard to beat something as simple as: varf a(u, v) = int3d(mesh)([dx(u), dy(u), dz(u)]' * [dx(v), dy(v), dz(v)]) + int3d(mesh)(f * v) + on(boundary mesh)(u = 0) Much More in F. Hecht s talk tomorrow F. Nataf et al BB DDM 22 / 28

25 Strong scalability in two dimensions heterogeneous elasticity (P. Jolivet with Frefeem ++) Elasticity problem with heterogeneous coefficients Timing relative to processes Linear speedup 10 #iterations #processes Speed-up for a 1.2 billion unknowns 2D problem. Direct solvers in the subdomains. Peak performance wall-clock time: 26s. F. Nataf et al BB DDM 23 / 28

26 Strong scalability in three dimensions heterogeneous elasticity Elasticity problem with heterogeneous coefficients Timing relative to processes Linear speedup 10 #iterations #processes Speed-up for a 160 million unknowns 3D problem. Direct solvers in subdomains. Peak performance wall-clock time: 36s. F. Nataf et al BB DDM 24 / 28

27 Weak scalability in two dimensions Darcy problems with heterogeneous coefficients Weak efficiency relative to processes 100 % 80 % 60 % 40 % 20 % 0 % #d.o.f. (in millions) #processes Efficiency for a 2D problem. Direct solvers in the subdomains. Final size: 22 billion unknowns. Wall-clock time: 200s. F. Nataf et al BB DDM 25 / 28

28 Weak scalability in three dimensions Darcy problems with heterogeneous coefficients Weak e ciency relative to processes 100 % 80 % 60 % 40 % 20 % 0% #d.o.f. (in millions) #processes Efficiency for a 3D problem. Direct solvers in the subdomains. Final size: 2 billion unknowns. Wall-clock time: 200s. F. Nataf et al BB DDM 26 / 28

29 Outline 1 Some Applications 2 An abstract 2-level Schwarz: the GenEO algorithm 3 Conclusion F. Nataf et al BB DDM 27 / 28

30 Conclusion Summary Using generalized eigenvalue problems and projection preconditioning we are able to achieve a targeted convergence rate. Works for ASM, BNN and FETI methods This process can be implemented in a black box algorithm. Future work Build the coarse space on the fly. Multigrid like three (or more) level methods THANK YOU FOR YOUR ATTENTION! F. Nataf et al BB DDM 28 / 28

31 Conclusion Summary Using generalized eigenvalue problems and projection preconditioning we are able to achieve a targeted convergence rate. Works for ASM, BNN and FETI methods This process can be implemented in a black box algorithm. Future work Build the coarse space on the fly. Multigrid like three (or more) level methods THANK YOU FOR YOUR ATTENTION! F. Nataf et al BB DDM 28 / 28

Une méthode parallèle hybride à deux niveaux interfacée dans un logiciel d éléments finis

Une méthode parallèle hybride à deux niveaux interfacée dans un logiciel d éléments finis Une méthode parallèle hybride à deux niveaux interfacée dans un logiciel d éléments finis Frédéric Nataf Laboratory J.L. Lions (LJLL), CNRS, Alpines Inria and Univ. Paris VI Victorita Dolean (Univ. Nice

More information

Multilevel spectral coarse space methods in FreeFem++ on parallel architectures

Multilevel spectral coarse space methods in FreeFem++ on parallel architectures Multilevel spectral coarse space methods in FreeFem++ on parallel architectures Pierre Jolivet Laboratoire Jacques-Louis Lions Laboratoire Jean Kuntzmann DD 21, Rennes. June 29, 2012 In collaboration with

More information

HPDDM une bibliothèque haute performance unifiée pour les méthodes de décomposition de domaine

HPDDM une bibliothèque haute performance unifiée pour les méthodes de décomposition de domaine HPDDM une bibliothèque haute performance unifiée pour les méthodes de décomposition de domaine P. Jolivet and Frédéric Nataf Laboratory J.L. Lions, Univ. Paris VI, Equipe Alpines INRIA-LJLL et CNRS joint

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

Domain decomposition, hybrid methods, coarse space corrections

Domain decomposition, hybrid methods, coarse space corrections Domain decomposition, hybrid methods, coarse space corrections Victorita Dolean, Pierre Jolivet & Frédéric Nataf UNICE, ENSEEIHT & UPMC and CNRS CEMRACS 2016 18 22 July 2016 Outline 1 Introduction 2 Schwarz

More information

Adaptive Coarse Spaces and Multiple Search Directions: Tools for Robust Domain Decomposition Algorithms

Adaptive Coarse Spaces and Multiple Search Directions: Tools for Robust Domain Decomposition Algorithms Adaptive Coarse Spaces and Multiple Search Directions: Tools for Robust Domain Decomposition Algorithms Nicole Spillane Center for Mathematical Modelling at the Universidad de Chile in Santiago. July 9th,

More information

Recent advances in HPC with FreeFem++

Recent advances in HPC with FreeFem++ Recent advances in HPC with FreeFem++ Pierre Jolivet Laboratoire Jacques-Louis Lions Laboratoire Jean Kuntzmann Fourth workshop on FreeFem++ December 6, 2012 With F. Hecht, F. Nataf, C. Prud homme. Outline

More information

Overlapping Domain Decomposition Methods with FreeFem++

Overlapping Domain Decomposition Methods with FreeFem++ Overlapping Domain Decomposition Methods with FreeFem++ Pierre Jolivet, Frédéric Hecht, Frédéric Nataf, Christophe Prud Homme To cite this version: Pierre Jolivet, Frédéric Hecht, Frédéric Nataf, Christophe

More information

Overlapping domain decomposition methods withfreefem++

Overlapping domain decomposition methods withfreefem++ Overlapping domain decomposition methods withfreefem++ Pierre Jolivet 1,3, Frédéric Hecht 1, Frédéric Nataf 1, and Christophe Prud homme 2 1 Introduction Developping an efficient and versatile framework

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

JOHANNES KEPLER UNIVERSITY LINZ. Abstract Robust Coarse Spaces for Systems of PDEs via Generalized Eigenproblems in the Overlaps

JOHANNES KEPLER UNIVERSITY LINZ. Abstract Robust Coarse Spaces for Systems of PDEs via Generalized Eigenproblems in the Overlaps JOHANNES KEPLER UNIVERSITY LINZ Institute of Computational Mathematics Abstract Robust Coarse Spaces for Systems of PDEs via Generalized Eigenproblems in the Overlaps Nicole Spillane Frédérik Nataf Laboratoire

More information

An introduction to Schwarz methods

An introduction to Schwarz methods An introduction to Schwarz methods Victorita Dolean Université de Nice and University of Geneva École thematique CNRS Décomposition de domaine November 15-16, 2011 Outline 1 Introduction 2 Schwarz algorithms

More information

Multipréconditionnement adaptatif pour les méthodes de décomposition de domaine. Nicole Spillane (CNRS, CMAP, École Polytechnique)

Multipréconditionnement adaptatif pour les méthodes de décomposition de domaine. Nicole Spillane (CNRS, CMAP, École Polytechnique) Multipréconditionnement adaptatif pour les méthodes de décomposition de domaine Nicole Spillane (CNRS, CMAP, École Polytechnique) C. Bovet (ONERA), P. Gosselet (ENS Cachan), A. Parret Fréaud (SafranTech),

More information

Avancées récentes dans le domaine des solveurs linéaires Pierre Jolivet Journées inaugurales de la machine de calcul June 10, 2015

Avancées récentes dans le domaine des solveurs linéaires Pierre Jolivet Journées inaugurales de la machine de calcul June 10, 2015 spcl.inf.ethz.ch @spcl eth Avancées récentes dans le domaine des solveurs linéaires Pierre Jolivet Journées inaugurales de la machine de calcul June 10, 2015 Introduction Domain decomposition methods The

More information

Efficient domain decomposition methods for the time-harmonic Maxwell equations

Efficient domain decomposition methods for the time-harmonic Maxwell equations Efficient domain decomposition methods for the time-harmonic Maxwell equations Marcella Bonazzoli 1, Victorita Dolean 2, Ivan G. Graham 3, Euan A. Spence 3, Pierre-Henri Tournier 4 1 Inria Saclay (Defi

More information

Algebraic Adaptive Multipreconditioning applied to Restricted Additive Schwarz

Algebraic Adaptive Multipreconditioning applied to Restricted Additive Schwarz Algebraic Adaptive Multipreconditioning applied to Restricted Additive Schwarz Nicole Spillane To cite this version: Nicole Spillane. Algebraic Adaptive Multipreconditioning applied to Restricted Additive

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

Two-level Domain decomposition preconditioning for the high-frequency time-harmonic Maxwell equations

Two-level Domain decomposition preconditioning for the high-frequency time-harmonic Maxwell equations Two-level Domain decomposition preconditioning for the high-frequency time-harmonic Maxwell equations Marcella Bonazzoli 2, Victorita Dolean 1,4, Ivan G. Graham 3, Euan A. Spence 3, Pierre-Henri Tournier

More information

An Introduction to Domain Decomposition Methods: algorithms, theory and parallel implementation

An Introduction to Domain Decomposition Methods: algorithms, theory and parallel implementation An Introduction to Domain Decomposition Methods: algorithms, theory and parallel implementation Victorita Dolean, Pierre Jolivet, Frédéric ataf To cite this version: Victorita Dolean, Pierre Jolivet, Frédéric

More information

arxiv: v1 [math.na] 16 Dec 2015

arxiv: v1 [math.na] 16 Dec 2015 ANALYSIS OF A NEW HARMONICALLY ENRICHED MULTISCALE COARSE SPACE FOR DOMAIN DECOMPOSITION METHODS MARTIN J. GANDER, ATLE LONELAND, AND TALAL RAHMAN arxiv:52.05285v [math.na] 6 Dec 205 Abstract. We propose

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

IsogEometric Tearing and Interconnecting

IsogEometric Tearing and Interconnecting IsogEometric Tearing and Interconnecting Christoph Hofer and Ludwig Mitter Johannes Kepler University, Linz 26.01.2017 Doctoral Program Computational Mathematics Numerical Analysis and Symbolic Computation

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

Finite element programming by FreeFem++ advanced course

Finite element programming by FreeFem++ advanced course 1 / 37 Finite element programming by FreeFem++ advanced course Atsushi Suzuki 1 1 Cybermedia Center, Osaka University atsushi.suzuki@cas.cmc.osaka-u.ac.jp Japan SIAM tutorial 4-5, June 2016 2 / 37 Outline

More information

Various ways to use a second level preconditioner

Various ways to use a second level preconditioner Various ways to use a second level preconditioner C. Vuik 1, J.M. Tang 1, R. Nabben 2, and Y. Erlangga 3 1 Delft University of Technology Delft Institute of Applied Mathematics 2 Technische Universität

More information

Additive Average Schwarz Method for a Crouzeix-Raviart Finite Volume Element Discretization of Elliptic Problems

Additive Average Schwarz Method for a Crouzeix-Raviart Finite Volume Element Discretization of Elliptic Problems Additive Average Schwarz Method for a Crouzeix-Raviart Finite Volume Element Discretization of Elliptic Problems Atle Loneland 1, Leszek Marcinkowski 2, and Talal Rahman 3 1 Introduction In this paper

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

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

C. Vuik 1 R. Nabben 2 J.M. Tang 1

C. Vuik 1 R. Nabben 2 J.M. Tang 1 Deflation acceleration of block ILU preconditioned Krylov methods C. Vuik 1 R. Nabben 2 J.M. Tang 1 1 Delft University of Technology J.M. Burgerscentrum 2 Technical University Berlin Institut für Mathematik

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

Robust Domain Decomposition Preconditioners for Abstract Symmetric Positive Definite Bilinear Forms

Robust Domain Decomposition Preconditioners for Abstract Symmetric Positive Definite Bilinear Forms www.oeaw.ac.at Robust Domain Decomposition Preconditioners for Abstract Symmetric Positive Definite Bilinear Forms Y. Efendiev, J. Galvis, R. Lazarov, J. Willems RICAM-Report 2011-05 www.ricam.oeaw.ac.at

More information

Some Geometric and Algebraic Aspects of Domain Decomposition Methods

Some Geometric and Algebraic Aspects of Domain Decomposition Methods Some Geometric and Algebraic Aspects of Domain Decomposition Methods D.S.Butyugin 1, Y.L.Gurieva 1, V.P.Ilin 1,2, and D.V.Perevozkin 1 Abstract Some geometric and algebraic aspects of various domain decomposition

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

ANR Project DEDALES Algebraic and Geometric Domain Decomposition for Subsurface Flow

ANR Project DEDALES Algebraic and Geometric Domain Decomposition for Subsurface Flow ANR Project DEDALES Algebraic and Geometric Domain Decomposition for Subsurface Flow Michel Kern Inria Paris Rocquencourt Maison de la Simulation C2S@Exa Days, Inria Paris Centre, Novembre 2016 M. Kern

More information

Overlapping Schwarz preconditioners for Fekete spectral elements

Overlapping Schwarz preconditioners for Fekete spectral elements Overlapping Schwarz preconditioners for Fekete spectral elements R. Pasquetti 1, L. F. Pavarino 2, F. Rapetti 1, and E. Zampieri 2 1 Laboratoire J.-A. Dieudonné, CNRS & Université de Nice et Sophia-Antipolis,

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

The Conjugate Gradient Method

The Conjugate Gradient Method The Conjugate Gradient Method Classical Iterations We have a problem, We assume that the matrix comes from a discretization of a PDE. The best and most popular model problem is, The matrix will be as large

More information

On Iterative Substructuring Methods for Multiscale Problems

On Iterative Substructuring Methods for Multiscale Problems On Iterative Substructuring Methods for Multiscale Problems Clemens Pechstein Introduction Model Problem Let Ω R 2 or R 3 be a Lipschitz polytope with boundary Ω = Γ D Γ N, where Γ D Γ N = /0. We are interested

More information

Domain Decomposition solvers (FETI)

Domain Decomposition solvers (FETI) Domain Decomposition solvers (FETI) a random walk in history and some current trends Daniel J. Rixen Technische Universität München Institute of Applied Mechanics www.amm.mw.tum.de rixen@tum.de 8-10 October

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 High-Performance Parallel Hybrid Method for Large Sparse Linear Systems

A High-Performance Parallel Hybrid Method for Large Sparse Linear Systems Outline A High-Performance Parallel Hybrid Method for Large Sparse Linear Systems Azzam Haidar CERFACS, Toulouse joint work with Luc Giraud (N7-IRIT, France) and Layne Watson (Virginia Polytechnic Institute,

More information

An Adaptive Multipreconditioned Conjugate Gradient Algorithm

An Adaptive Multipreconditioned Conjugate Gradient Algorithm An Adaptive Multipreconditioned Conjugate Gradient Algorithm Nicole Spillane To cite this version: Nicole Spillane. An Adaptive Multipreconditioned Conjugate Gradient Algorithm. 2016. HAL Id: hal-01170059

More information

On the Robustness and Prospects of Adaptive BDDC Methods for Finite Element Discretizations of Elliptic PDEs with High-Contrast Coefficients

On the Robustness and Prospects of Adaptive BDDC Methods for Finite Element Discretizations of Elliptic PDEs with High-Contrast Coefficients On the Robustness and Prospects of Adaptive BDDC Methods for Finite Element Discretizations of Elliptic PDEs with High-Contrast Coefficients Stefano Zampini Computer, Electrical and Mathematical Sciences

More information

Electronic Transactions on Numerical Analysis Volume 49, 2018

Electronic Transactions on Numerical Analysis Volume 49, 2018 Electronic Transactions on Numerical Analysis Volume 49, 2018 Contents 1 Adaptive FETI-DP and BDDC methods with a generalized transformation of basis for heterogeneous problems. Axel Klawonn, Martin Kühn,

More information

THEORETICAL AND NUMERICAL COMPARISON OF PROJECTION METHODS DERIVED FROM DEFLATION, DOMAIN DECOMPOSITION AND MULTIGRID METHODS

THEORETICAL AND NUMERICAL COMPARISON OF PROJECTION METHODS DERIVED FROM DEFLATION, DOMAIN DECOMPOSITION AND MULTIGRID METHODS THEORETICAL AND NUMERICAL COMPARISON OF PROJECTION METHODS DERIVED FROM DEFLATION, DOMAIN DECOMPOSITION AND MULTIGRID METHODS J.M. TANG, R. NABBEN, C. VUIK, AND Y.A. ERLANGGA Abstract. For various applications,

More information

Schwarz Preconditioner for the Stochastic Finite Element Method

Schwarz Preconditioner for the Stochastic Finite Element Method Schwarz Preconditioner for the Stochastic Finite Element Method Waad Subber 1 and Sébastien Loisel 2 Preprint submitted to DD22 conference 1 Introduction The intrusive polynomial chaos approach for uncertainty

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning

AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 23: GMRES and Other Krylov Subspace Methods; Preconditioning Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 18 Outline

More information

An Introduction to Domain Decomposition Methods

An Introduction to Domain Decomposition Methods An Introduction to Domain Decomposition Methods Algorithms, Theory, and Parallel Implementation Victorita Dolean Pierre Jolivet Frédéric Nataf An Introduction to Domain Decomposition Methods An Introduction

More information

Sparse linear solvers: iterative methods and preconditioning

Sparse linear solvers: iterative methods and preconditioning Sparse linear solvers: iterative methods and preconditioning L Grigori ALPINES INRIA and LJLL, UPMC March 2017 Plan Sparse linear solvers Sparse matrices and graphs Classes of linear solvers Krylov subspace

More information

Iterative Helmholtz Solvers

Iterative Helmholtz Solvers Iterative Helmholtz Solvers Scalability of deflation-based Helmholtz solvers Delft University of Technology Vandana Dwarka March 28th, 2018 Vandana Dwarka (TU Delft) 15th Copper Mountain Conference 2018

More information

Parallel sparse linear solvers and applications in CFD

Parallel sparse linear solvers and applications in CFD Parallel sparse linear solvers and applications in CFD Jocelyne Erhel Joint work with Désiré Nuentsa Wakam () and Baptiste Poirriez () SAGE team, Inria Rennes, France journée Calcul Intensif Distribué

More information

Architecture Solutions for DDM Numerical Environment

Architecture Solutions for DDM Numerical Environment Architecture Solutions for DDM Numerical Environment Yana Gurieva 1 and Valery Ilin 1,2 1 Institute of Computational Mathematics and Mathematical Geophysics SB RAS, Novosibirsk, Russia 2 Novosibirsk State

More information

A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation

A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation Tao Zhao 1, Feng-Nan Hwang 2 and Xiao-Chuan Cai 3 Abstract In this paper, we develop an overlapping domain decomposition

More information

arxiv: v1 [cs.ce] 9 Jul 2016

arxiv: v1 [cs.ce] 9 Jul 2016 Microwave Tomographic Imaging of Cerebrovascular Accidents by Using High-Performance Computing arxiv:1607.02573v1 [cs.ce] 9 Jul 2016 P.-H. Tournier a,b, I. Aliferis c, M. Bonazzoli d, M. de Buhan e, M.

More information

Adding a new finite element to FreeFem++:

Adding a new finite element to FreeFem++: Adding a new finite element to FreeFem++: the example of edge elements Marcella Bonazzoli 1 2, Victorita Dolean 1,3, Frédéric Hecht 2, Francesca Rapetti 1, Pierre-Henri Tournier 2 1 LJAD, University of

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

Shifted Laplace and related preconditioning for the Helmholtz equation

Shifted Laplace and related preconditioning for the Helmholtz equation Shifted Laplace and related preconditioning for the Helmholtz equation Ivan Graham and Euan Spence (Bath, UK) Collaborations with: Paul Childs (Schlumberger Gould Research), Martin Gander (Geneva) Douglas

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

SOME PRACTICAL ASPECTS OF PARALLEL ADAPTIVE BDDC METHOD

SOME PRACTICAL ASPECTS OF PARALLEL ADAPTIVE BDDC METHOD Conference Applications of Mathematics 2012 in honor of the 60th birthday of Michal Křížek. Institute of Mathematics AS CR, Prague 2012 SOME PRACTICAL ASPECTS OF PARALLEL ADAPTIVE BDDC METHOD Jakub Šístek1,2,

More information

Open-source finite element solver for domain decomposition problems

Open-source finite element solver for domain decomposition problems 1/29 Open-source finite element solver for domain decomposition problems C. Geuzaine 1, X. Antoine 2,3, D. Colignon 1, M. El Bouajaji 3,2 and B. Thierry 4 1 - University of Liège, Belgium 2 - University

More information

Fakultät für Mathematik und Informatik

Fakultät für Mathematik und Informatik Fakultät für Mathematik und Informatik Preprint 2016-09 Alexander Heinlein, Axel Klawonn, Jascha Knepper, Oliver Rheinbach Multiscale Coarse Spaces for Overlapping Schwarz Methods Based on the ACMS Space

More information

Chapter 7 Iterative Techniques in Matrix Algebra

Chapter 7 Iterative Techniques in Matrix Algebra Chapter 7 Iterative Techniques in Matrix Algebra Per-Olof Persson persson@berkeley.edu Department of Mathematics University of California, Berkeley Math 128B Numerical Analysis Vector Norms Definition

More information

Lecture 17: Iterative Methods and Sparse Linear Algebra

Lecture 17: Iterative Methods and Sparse Linear Algebra Lecture 17: Iterative Methods and Sparse Linear Algebra David Bindel 25 Mar 2014 Logistics HW 3 extended to Wednesday after break HW 4 should come out Monday after break Still need project description

More information

Deflated Krylov Iterations in Domain Decomposition Methods

Deflated Krylov Iterations in Domain Decomposition Methods 305 Deflated Krylov Iterations in Domain Decomposition Methods Y.L.Gurieva 1, V.P.Ilin 1,2, and D.V.Perevozkin 1 1 Introduction The goal of this research is an investigation of some advanced versions of

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

On domain decomposition preconditioners for finite element approximations of the Helmholtz equation using absorption

On domain decomposition preconditioners for finite element approximations of the Helmholtz equation using absorption On domain decomposition preconditioners for finite element approximations of the Helmholtz equation using absorption Ivan Graham and Euan Spence (Bath, UK) Collaborations with: Paul Childs (Emerson Roxar,

More information

Parallel Preconditioning Methods for Ill-conditioned Problems

Parallel Preconditioning Methods for Ill-conditioned Problems Parallel Preconditioning Methods for Ill-conditioned Problems Kengo Nakajima Information Technology Center, The University of Tokyo 2014 Conference on Advanced Topics and Auto Tuning in High Performance

More information

Bath Institute For Complex Systems

Bath Institute For Complex Systems BICS Bath Institute for Complex Systems Energy Minimizing Coarse Spaces for Two-level Schwarz Methods for Multiscale PDEs J. Van lent, R. Scheichl and I.G. Graham Bath Institute For Complex Systems Preprint

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

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

Linear and Non-Linear Preconditioning

Linear and Non-Linear Preconditioning and Non- martin.gander@unige.ch University of Geneva July 2015 Joint work with Victorita Dolean, Walid Kheriji, Felix Kwok and Roland Masson (1845): First Idea of After preconditioning, it takes only three

More information

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Eugene Vecharynski 1 Andrew Knyazev 2 1 Department of Computer Science and Engineering University of Minnesota 2 Department

More information

Lecture 8: Fast Linear Solvers (Part 7)

Lecture 8: Fast Linear Solvers (Part 7) Lecture 8: Fast Linear Solvers (Part 7) 1 Modified Gram-Schmidt Process with Reorthogonalization Test Reorthogonalization If Av k 2 + δ v k+1 2 = Av k 2 to working precision. δ = 10 3 2 Householder Arnoldi

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

New constructions of domain decomposition methods for systems of PDEs

New constructions of domain decomposition methods for systems of PDEs New constructions of domain decomposition methods for systems of PDEs Nouvelles constructions de méthodes de décomposition de domaine pour des systèmes d équations aux dérivées partielles V. Dolean?? F.

More information

Multigrid and Iterative Strategies for Optimal Control Problems

Multigrid and Iterative Strategies for Optimal Control Problems Multigrid and Iterative Strategies for Optimal Control Problems John Pearson 1, Stefan Takacs 1 1 Mathematical Institute, 24 29 St. Giles, Oxford, OX1 3LB e-mail: john.pearson@worc.ox.ac.uk, takacs@maths.ox.ac.uk

More information

Solving Large Nonlinear Sparse Systems

Solving Large Nonlinear Sparse Systems Solving Large Nonlinear Sparse Systems Fred W. Wubs and Jonas Thies Computational Mechanics & Numerical Mathematics University of Groningen, the Netherlands f.w.wubs@rug.nl Centre for Interdisciplinary

More information

The Deflation Accelerated Schwarz Method for CFD

The Deflation Accelerated Schwarz Method for CFD The Deflation Accelerated Schwarz Method for CFD J. Verkaik 1, C. Vuik 2,, B.D. Paarhuis 1, and A. Twerda 1 1 TNO Science and Industry, Stieltjesweg 1, P.O. Box 155, 2600 AD Delft, The Netherlands 2 Delft

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

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

Linear Solvers. Andrew Hazel

Linear Solvers. Andrew Hazel Linear Solvers Andrew Hazel Introduction Thus far we have talked about the formulation and discretisation of physical problems...... and stopped when we got to a discrete linear system of equations. Introduction

More information

A Numerical Study of Some Parallel Algebraic Preconditioners

A Numerical Study of Some Parallel Algebraic Preconditioners A Numerical Study of Some Parallel Algebraic Preconditioners Xing Cai Simula Research Laboratory & University of Oslo PO Box 1080, Blindern, 0316 Oslo, Norway xingca@simulano Masha Sosonkina University

More information

Multigrid absolute value preconditioning

Multigrid absolute value preconditioning Multigrid absolute value preconditioning Eugene Vecharynski 1 Andrew Knyazev 2 (speaker) 1 Department of Computer Science and Engineering University of Minnesota 2 Department of Mathematical and Statistical

More information

arxiv: v2 [physics.comp-ph] 3 Jun 2016

arxiv: v2 [physics.comp-ph] 3 Jun 2016 INTERNATIONAL JOURNAL OF NUMERICAL MODELLING: ELECTRONIC NETWORKS, DEVICES AND FIELDS Int. J. Numer. Model. 2016; 00:1 10 Published online in Wiley InterScience (www.interscience.wiley.com). Parallel preconditioners

More information

A dissection solver with kernel detection for unsymmetric matrices in FreeFem++

A dissection solver with kernel detection for unsymmetric matrices in FreeFem++ . p.1/21 11 Dec. 2014, LJLL, Paris FreeFem++ workshop A dissection solver with kernel detection for unsymmetric matrices in FreeFem++ Atsushi Suzuki Atsushi.Suzuki@ann.jussieu.fr Joint work with François-Xavier

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

FETI-DP for Elasticity with Almost Incompressible 2 Material Components 3 UNCORRECTED PROOF. Sabrina Gippert, Axel Klawonn, and Oliver Rheinbach 4

FETI-DP for Elasticity with Almost Incompressible 2 Material Components 3 UNCORRECTED PROOF. Sabrina Gippert, Axel Klawonn, and Oliver Rheinbach 4 1 FETI-DP for Elasticity with Almost Incompressible 2 Material Components 3 Sabrina Gippert, Axel Klawonn, and Oliver Rheinbach 4 Lehrstuhl für Numerische Mathematik, Fakultät für Mathematik, Universität

More information

Scalable domain decomposition preconditioners for heterogeneous elliptic problems 1

Scalable domain decomposition preconditioners for heterogeneous elliptic problems 1 Scientific Programming 22 (2014) 157 171 157 DOI 10.3233/SPR-140381 IOS Press Scalable domain decomposition preconditioners for heterogeneous elliptic problems 1 Pierre Jolivet a,b,c,, Frédéric Hecht b,c,

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

J.I. Aliaga 1 M. Bollhöfer 2 A.F. Martín 1 E.S. Quintana-Ortí 1. March, 2009

J.I. Aliaga 1 M. Bollhöfer 2 A.F. Martín 1 E.S. Quintana-Ortí 1. March, 2009 Parallel Preconditioning of Linear Systems based on ILUPACK for Multithreaded Architectures J.I. Aliaga M. Bollhöfer 2 A.F. Martín E.S. Quintana-Ortí Deparment of Computer Science and Engineering, Univ.

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

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

Comparison of the deflated preconditioned conjugate gradient method and algebraic multigrid for composite materials

Comparison of the deflated preconditioned conjugate gradient method and algebraic multigrid for composite materials Comput Mech (2012) 50:321 333 DOI 10.1007/s00466-011-0661-y ORIGINAL PAPER Comparison of the deflated preconditioned conjugate gradient method and algebraic multigrid for composite materials T. B. Jönsthövel

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

A two-level domain-decomposition preconditioner for the time-harmonic Maxwell s equations

A two-level domain-decomposition preconditioner for the time-harmonic Maxwell s equations A two-level domain-decomposition preconditioner for the time-harmonic Maxwell s equations Marcella Bonazzoli, Victorita Dolean, Ivan Graham, Euan Spence, Pierre-Henri Tournier To cite this version: Marcella

More information

Application of Preconditioned Coupled FETI/BETI Solvers to 2D Magnetic Field Problems

Application of Preconditioned Coupled FETI/BETI Solvers to 2D Magnetic Field Problems Application of Preconditioned Coupled FETI/BETI Solvers to 2D Magnetic Field Problems U. Langer A. Pohoaţǎ O. Steinbach 27th September 2004 Institute of Computational Mathematics Johannes Kepler University

More information

Fine-grained Parallel Incomplete LU Factorization

Fine-grained Parallel Incomplete LU Factorization Fine-grained Parallel Incomplete LU Factorization Edmond Chow School of Computational Science and Engineering Georgia Institute of Technology Sparse Days Meeting at CERFACS June 5-6, 2014 Contribution

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

arxiv: v2 [math.na] 20 May 2016

arxiv: v2 [math.na] 20 May 2016 GEOMETRIC MULTIGRID FOR DARCY AND BRINKMAN MODELS OF FLOWS IN HIGHLY HETEROGENEOUS POROUS MEDIA: A NUMERICAL STUDY arxiv:1602.04858v2 [math.na] 20 May 2016 GUIDO KANSCHAT, RAYTCHO LAZAROV, AND YOULI MAO

More information

Asymptotic expansions for high-contrast elliptic equations

Asymptotic expansions for high-contrast elliptic equations Asymptotic expansions for high-contrast elliptic equations Victor M. Calo Yalchin Efendiev Juan Galvis 1 Abstract In this paper, we present a high-order expansion for elliptic equations in highcontrast

More information