Schwarz-type methods and their application in geomechanics

Size: px
Start display at page:

Download "Schwarz-type methods and their application in geomechanics"

Transcription

1 Schwarz-type methods and their application in geomechanics R. Blaheta, O. Jakl, K. Krečmer, J. Starý Institute of Geonics AS CR, Ostrava, Czech Republic PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 1/23

2 Contents Introduction Iterative solvers Space decomposition Displacement decomposition Domain decomposition Two-level domain decomposition Parallel implementation Testing environment Academic model problem, results Large-scale real-life problem, results Two-level hybrid preconditioners Testing of solvers, results Present and future work, conclusion PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 2/23

3 Introduction Many physical phenomena can be simulated with the aid of the finite element (FE) method. In many cases, this simulation leads to huge computational demands, which are concentrated mainly to the solution of large-scale systems of linear equations. We shall consider the case, when the investigated physical phenomena are described by elasticity problems on domain Ω R 3. We shall also assume that the FE discretization of these boundary value problems leads to the solution of large-scale systems of the type Au = f, u, f R n, where A is a symmetric positive definite n n matrix. Such systems arise also e.g. from mathematical modelling of stationary diffusion, heat conduction or filtration. PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 3/23

4 Iterative solvers PCG method: GPCG[m] method: r 0 = f Au 0 v 0 = g 0 = G(r 0 ) σ 0 = g 0, r 0 for i = 0, 1,... until r i ε f : w = Av i α = σ i / v i, w u i+1 = u i + αv i r i+1 = r i αw g i+1 = G(r i+1 ) σ i+1 = g i+1, r i+1 β = σ i+1 /σ i r 0 = f Au 0 v 0 = g 0 = G(r 0 ) σ 0 = g 0, r 0 for i = 0, 1,... until r i ε f : w = Av i α = σ i / v i, w u i+1 = u i + αv i r i+1 = r i αw g i+1 = G(r i+1 ) σ i+1 = g i+1, r i+1 v i+1 = g i+1 end v i+1 = g i+1 + βv i for k = min{i + 1, m},..., 1: w = r i+2 k r i+1 k Solvers: sequential parallel data decomposition & parallel operations (matrix by vector multiplication, vector updates,... ) construction of efficient preconditioner & its effective implementation end end βi+1 k = g i+1, w /σ i+1 k v i+1 = v i+1 + βi+1 k v i+1 k Note: In our computations ε = PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 4/23

5 Space decomposition V = V V p, V R n, V k R n k V k, V l... do not need to be linearly independent Restrictions: Prolongations: Decomposition of A: R k : R n R n k R k v 1. v p = vk I k : R n k R n [ 0 I k v k = v k 0 ] A = A 11 A 1p A p1 A pp Algorithm g = G(r): g 0 = 0 for k = 1,..., p: end g k = g k 1 + I k A 1 kk R kz k Type of preconditioning: additive: z k = r multiplicative: z k = (r Ag k 1 ) Solution of A 1 kk : exactly, e.g. by an incomplete factorization inexactly, e.g. by inner (PCG) iterations (up to some lower accuracy, ε = 10 1 ) PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 5/23

6 Displacement decomposition u = (u 1,..., u N ), u i = u ix u iy u iz, V = V x + V y + V z ND = 3 NN {}}{ X 1Y 1Z 1X 2Y 2Z 2... NN ND {}}{ NN NN {}}{{}}{{}}{ X 1X 2... Y 1Y 2... Z 1Z 2... X 1 Y 1 Z 1 X 2 Y 2 Z 2... A X 1 Y 1 Z 1 X 2 Y 2 Z 2... X 1 X 2... Y 1 Y 2... A 11 A 12 A 13 X 1 X 2... Y 1 Y 2... A 21 A 22 A 23 Z 1 Z 2... Z 1 Z 2... stiffness matrix vector A 31 A 32 A 33 stiffness matrix vector v = v 1 v 2 v 3 A = A 11 A 12 A 13 A 21 A 22 A 23 A 31 A 32 A 33 B = A 11 A 22 A 33 This technique naturally allows to split computations just among 3 concurrent tasks. A full scalability of computations is possible only in combination with another SD technique. Blocks in preconditioner are completely independent, therefore no communication of concurrent tasks during the preconditioning is needed. PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 6/23

7 Domain decomposition Ω = p Ω i, V = p i=1 i=1 V i, V i = {v V : v = 0 in Ω\Ω i } Y Z X Ω Ω 1 Ω 2 Ω Ω 1 Ω 2 Ω 3 X 1 Y 1 Z 1 X 2 Y 2 Z 2... ND = 3 NN {}}{ X 1Y 1Z 1X 2Y 2Z 2... A stiffness matrix X 1 Y 1 Z 1 X 2 Y 2 Z 2... vector X 1 Y 1 Z 1 X 2 Y 2 Z 2... X 1Y 1Z 1X 2Y 2Z 2... A 1 A 2 stiffness matrix A 3 X 1 Y 1 Z 1 X 2 Y 2 Z 2... vector An advantage of domain decomposition in only dimension: each of concurrent tasks has to communicate with at most two others corresponding to neighbouring subdomains. Nonoverlapping sds. - block Jacobi: g = G 1 (r) = p i=1 I i à 1 i R i r Overlapping sds. - additive Schwarz: g = G 2 (r) = p i=1 I i A 1 i R i r PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 7/23

8 Two-level domain decomposition Coarse grid: p V = V c + V i, A c, R c, I c i=1 Aggregations: Y Z X Ω Ω c A construction of R c, I c depends on fact, if the coarse grid is nested or non-nested. Two-level additive Schwarz: g = G 3 (r) = G 2 (r) + I c A 1 c R c r An example of regular aggregations. In practice, it is often impossible to make the explicit coarse grid or too much time demanding to make or use R c, I c. In this case, aggregations allow a simple construction of A c, R c, I c. PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 8/23

9 Parallel implementation step k th worker process communication l th worker process data in memory: data in memory: u k, v k, r k, g k, w k w kk, A kk u l, v l, r l, g l, w l w ll, A ll w ki, A ik, i = 1,..., m, i k w li, A il, i = 1,..., m, i l S 1 for i = 1,..., m : w ki = A ik v k for i = 1,..., m : w li = A il v l C 1 = w kl w lk = m m S 2 w k = ik w l = il i=1 i=1 S 3 s k = w k, v k s l = w l, v l m C 2 s = i i=1 S 4 α = s 0 /s α = s 0 /s u k = u k + αv k u l = u l + αv l r k = r k αw k r l = r l αw l S 5, C 3 g = G(r) r k, r l g = G(r) S 6 s k = g k, r k s l = g l, r l m C 4 s 1 = s i i=1 S 7 β = s 1 /s 0 β = s 1 /s 0 s 0 = s 1 s 0 = s 1 v k = g k + βv k v l = g l + βv l The worker-to-worker implementation of one iteration of the parallel CG algorithm with a Schwarz-type preconditioner. PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 9/23

10 Testing environment The parallel implementation of our solvers was realized in Fortran 77 with the aid of PVM, MPI (MPICH or LAM) or PETSc. We used the following parallel computers: Lomond (EPCC Edinburgh): Sun HPC cluster. Front-end: SMP system HPC 3500 with 8 UltraSPARC-II/400 and 8 GB of shared memory. Back-end: 2 SMP system Sunfire 6800 with 24 UltraSPARC-III/750 and 48 GB of shared memory. OS Solaris 2.8, Sun Grid Engine, MPI (Sun), PETSc (2.1.3). Thea (IGAS Ostrava): a Beowulf cluster, file server + interactive node + 8 nodes, each equipped by AMD Athlon/1400, 768 MB of memory, 2 FastEthernet. OS Debian Linux, MPI (MPICH or LAM 6.5.6), PVM (3.4.2), PETSc (2.1.3 and 2.2.0). interactive node computing nodes to Inter/Intranet FastEth. (system) switch FastEth. (appl.) Gigabit file server to Inter/Intranet PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 10/23

11 Academic model problem As a basic test problem, we use the square footing, which is a 3D elasticity problem of soil mechanics. The square area m on the top side of the domain m is loaded by the uniform pressure equal to 2.4 MPa. Due to the symmetry of the considered domain, we work only with its quarter discretized by a rectangular grid with a grid refinement under the footing. Benchmark Used grid # Equations FOOT 40 E FOOT 60 E PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 11/23

12 Lomond - numbers of iterations Test: FOOT 60 E PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 12/23

13 Lomond - times Test: FOOT 60 E PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 13/23

14 Thea - times Test: FOOT 60 E PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 14/23

15 Large-scale real-life problem Another benchmark problem is derived from the real-life large-scale mathematical model of a uranium ore mine Dolní Rožínka (DR) in the Bohemian-Moravian Highlands. The model is considered for the comparison of different mining methods in relation to a development of induced stress fields and a possibility of dangerous rockbursts. Since we presented the procedure and results in a fairly detailed manner already, in this place we will only summarize them. The DR model considers a domain of meters located 800 meters bellow surface. East-West cross-section of the deposit Rožná and the considered area in the left down corner. PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 15/23

16 Dolní Rožínka The domain is discretized by a regular grid of nodes and the resulting linear system has DOF. Z X Y The FE mesh. The whole task simulates four stages of mining, represented by a four-step sequence of problems with different material distributions. For needs to use the big-size testing problem only, we work with the last step of the whole modelling sequence. PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 16/23

17 Results Lomond Thea Solver # P # It T [s] # It T [s] SEQ-IF DiD-IF DiD-II DiD-II* DD-AS DD-AS DD-AS DD-AS DD-AS DD-2LAS DD-2LAS DD-2LAS DD-2LAS DD-2LAS * for the GPCG[1] method PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 17/23

18 Two-level hybrid preconditioners Define: B = p k=1 I k A 1 k R k B c = I c A 1 c R c I k = R T k, I c = R T c Consider the following Schwarz-type preconditioners g = G(r): 1L aditive m. g = Br 2L aditive m. g = Br + B c r 2L nonsymmetric hybrid m. g = Br g = g + B c (r Ag) 2L reverse nonsymmetric hybrid m. g = B c r g = g + B(r Ag) 2L symmetric hybrid m. g = Br g = g + B c (r Ag) g = g + B(r Ag) 2L symmetric averaged hybrid m. g F = Br g C = B c r g F = g F + B(r Ag F ) g C = g C + B c (r Ag C ) g = 1 2 (g F + g C ) 2L symmetric smoothed hybrid m. (with overcorrection η) g = Br g = g + B(r Ag) g = g + ηb c (r Ag) g = g + B(r Ag) g = g + B(r Ag) PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 18/23

19 Thea - numbers of iterations Test: FOOT 40 E Preconditioner: Number of processors type and properties A one-level A two-level H two-level symmetric H nonsymmetric H reverse nonsymmetric H symmetric smoothed without overcorrection H symmetric smoothed with overcorrection η = H symmetric, averaged for GPCG[1] method only PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 19/23

20 Thea - times Test: FOOT 40 E Preconditioner: Number of processors type and properties A one-level A two-level H two-level symmetric % H nonsymmetric H reverse nonsymmetric H symmetric smoothed without overcorrection H symmetric smoothed with overcorrection η = H symmetric, averaged for GPCG[1] method only PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 20/23

21 Thea - number of iterations Test: FOOT 40 E Symmetric hybrid preconditioner with overcorrection: influence of overcorrection η η Number of processors η Number of processors PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 21/23

22 Present and future work Coarse grid with interfaces: Original grid Subdomain 1 Subdomain 2 Aggregations out of interface Coarse grid with interface PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 22/23

23 Conclusion This work outlines parallel implementation of the conjugate gradient method with various preconditioners and shows some applications of the implemented methods. The results prove that such parallel solvers enable efficient solution of large-scale real-life engineering problems even on clusters of common and relatively cheap PC s. Acknowledgment: Authors are grateful for the support of the Academy of Sceinces of the Czech Republic, contract No. S , and the Grant Agency of the Czech Republic, contract No. 105/04/P036. PDEMAMIP, September 7-11, 2004,Sunny Beach, Bulgaria R. Blaheta, O. Jakl, K. Krečmer, J. Starý: Schwarz-type methods and their application in geomechanics page 23/23

The Evaluation of the Thermal Behaviour of an Underground Repository of the Spent Nuclear Fuel

The Evaluation of the Thermal Behaviour of an Underground Repository of the Spent Nuclear Fuel The Evaluation of the Thermal Behaviour of an Underground Repository of the Spent Nuclear Fuel Roman Kohut, Jiří Starý, and Alexej Kolcun Institute of Geonics, Academy of Sciences of the Czech Republic,

More information

High Performance Computing Applications

High Performance Computing Applications BULGARIAN ACADEMY OF SCIENCES CYBERNETICS AND INFORMATION TECHNOLOGIES Volume 17, No 5 Special issue with selected papers from the workshop Two Years Avitohol: Advanced High Performance Computing Applications

More information

arxiv: v1 [math.na] 28 Feb 2008

arxiv: v1 [math.na] 28 Feb 2008 BDDC by a frontal solver and the stress computation in a hip joint replacement arxiv:0802.4295v1 [math.na] 28 Feb 2008 Jakub Šístek a, Jaroslav Novotný b, Jan Mandel c, Marta Čertíková a, Pavel Burda a

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

Comparative Analysis of Mesh Generators and MIC(0) Preconditioning of FEM Elasticity Systems

Comparative Analysis of Mesh Generators and MIC(0) Preconditioning of FEM Elasticity Systems Comparative Analysis of Mesh Generators and MIC(0) Preconditioning of FEM Elasticity Systems Nikola Kosturski and Svetozar Margenov Institute for Parallel Processing, Bulgarian Academy of Sciences Abstract.

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

MPI parallel implementation of CBF preconditioning for 3D elasticity problems 1

MPI parallel implementation of CBF preconditioning for 3D elasticity problems 1 Mathematics and Computers in Simulation 50 (1999) 247±254 MPI parallel implementation of CBF preconditioning for 3D elasticity problems 1 Ivan Lirkov *, Svetozar Margenov Central Laboratory for Parallel

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

Conjugate Gradients: Idea

Conjugate Gradients: Idea Overview Steepest Descent often takes steps in the same direction as earlier steps Wouldn t it be better every time we take a step to get it exactly right the first time? Again, in general we choose a

More information

Contents. Preface... xi. Introduction...

Contents. Preface... xi. Introduction... Contents Preface... xi Introduction... xv Chapter 1. Computer Architectures... 1 1.1. Different types of parallelism... 1 1.1.1. Overlap, concurrency and parallelism... 1 1.1.2. Temporal and spatial parallelism

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

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

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

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

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

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

Modelling of THM processes in rocks [Geonics 2007]

Modelling of THM processes in rocks [Geonics 2007] Modelling of THM processes in rocks [Geonics 200] R. BLAHETA 1, R. KOHUT 1, M. NETCHEVA 2 & J. STARÝ 1 1 Institute of Geonics AS CR, Ostrava 2 Uppsala University, Department of Information Technology Abstrakt

More information

1. Fast Iterative Solvers of SLE

1. Fast Iterative Solvers of SLE 1. Fast Iterative Solvers of crucial drawback of solvers discussed so far: they become slower if we discretize more accurate! now: look for possible remedies relaxation: explicit application of the multigrid

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

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

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

Model Order Reduction via Matlab Parallel Computing Toolbox. Istanbul Technical University

Model Order Reduction via Matlab Parallel Computing Toolbox. Istanbul Technical University Model Order Reduction via Matlab Parallel Computing Toolbox E. Fatih Yetkin & Hasan Dağ Istanbul Technical University Computational Science & Engineering Department September 21, 2009 E. Fatih Yetkin (Istanbul

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

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

Domain Decomposition-based contour integration eigenvalue solvers

Domain Decomposition-based contour integration eigenvalue solvers Domain Decomposition-based contour integration eigenvalue solvers Vassilis Kalantzis joint work with Yousef Saad Computer Science and Engineering Department University of Minnesota - Twin Cities, USA SIAM

More information

Domain decomposition on different levels of the Jacobi-Davidson method

Domain decomposition on different levels of the Jacobi-Davidson method hapter 5 Domain decomposition on different levels of the Jacobi-Davidson method Abstract Most computational work of Jacobi-Davidson [46], an iterative method suitable for computing solutions of large dimensional

More information

Engine-Gasket HPC trial and Suspension NVH analysis using Linear_Perturbation ANSYS Japan Mechanical BU Toru Hiyake

Engine-Gasket HPC trial and Suspension NVH analysis using Linear_Perturbation ANSYS Japan Mechanical BU Toru Hiyake Engine-Gasket HPC trial and Suspension NVH analysis using Linear_Perturbation ANSYS Japan Mechanical BU Toru Hiyake Agenda Topic 1 : Engine-Gasket Nonlinear Analysis Legacy Data Import Gasket modeling

More information

FETI domain decomposition method to solution of contact problems with large displacements

FETI domain decomposition method to solution of contact problems with large displacements FETI domain decomposition method to solution of contact problems with large displacements Vít Vondrák 1, Zdeněk Dostál 1, Jiří Dobiáš 2, and Svatopluk Pták 2 1 Dept. of Appl. Math., Technical University

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

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

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

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

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

The Plane Stress Problem

The Plane Stress Problem The Plane Stress Problem Martin Kronbichler Applied Scientific Computing (Tillämpad beräkningsvetenskap) February 2, 2010 Martin Kronbichler (TDB) The Plane Stress Problem February 2, 2010 1 / 24 Outline

More information

Robust solution of Poisson-like problems with aggregation-based AMG

Robust solution of Poisson-like problems with aggregation-based AMG Robust solution of Poisson-like problems with aggregation-based AMG Yvan Notay Université Libre de Bruxelles Service de Métrologie Nucléaire Paris, January 26, 215 Supported by the Belgian FNRS http://homepages.ulb.ac.be/

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

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

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

- Part 4 - Multicore and Manycore Technology: Chances and Challenges. Vincent Heuveline

- Part 4 - Multicore and Manycore Technology: Chances and Challenges. Vincent Heuveline - Part 4 - Multicore and Manycore Technology: Chances and Challenges Vincent Heuveline 1 Numerical Simulation of Tropical Cyclones Goal oriented adaptivity for tropical cyclones ~10⁴km ~1500km ~100km 2

More information

A parallel exponential integrator for large-scale discretizations of advection-diffusion models

A parallel exponential integrator for large-scale discretizations of advection-diffusion models A parallel exponential integrator for large-scale discretizations of advection-diffusion models L. Bergamaschi 1, M. Caliari 2, A. Martínez 3, and M. Vianello 3 1 Department of Mathematical Methods and

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

arxiv: v1 [math.na] 11 Jul 2011

arxiv: v1 [math.na] 11 Jul 2011 Multigrid Preconditioner for Nonconforming Discretization of Elliptic Problems with Jump Coefficients arxiv:07.260v [math.na] Jul 20 Blanca Ayuso De Dios, Michael Holst 2, Yunrong Zhu 2, and Ludmil Zikatanov

More information

Discontinuous Galerkin methods for nonlinear elasticity

Discontinuous Galerkin methods for nonlinear elasticity Discontinuous Galerkin methods for nonlinear elasticity Preprint submitted to lsevier Science 8 January 2008 The goal of this paper is to introduce Discontinuous Galerkin (DG) methods for nonlinear elasticity

More information

Algebraic Multigrid as Solvers and as Preconditioner

Algebraic Multigrid as Solvers and as Preconditioner Ò Algebraic Multigrid as Solvers and as Preconditioner Domenico Lahaye domenico.lahaye@cs.kuleuven.ac.be http://www.cs.kuleuven.ac.be/ domenico/ Department of Computer Science Katholieke Universiteit Leuven

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

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

On the adaptive time-stepping for large-scale parabolic problems: computer simulation of heat and mass transfer in vacuum freeze-drying

On the adaptive time-stepping for large-scale parabolic problems: computer simulation of heat and mass transfer in vacuum freeze-drying On the adaptive time-stepping for large-scale parabolic problems: computer simulation of heat and mass transfer in vacuum freeze-drying Krassimir Georgiev, Nikola Kosturski, Svetozar Margenov Institute

More information

A User Friendly Toolbox for Parallel PDE-Solvers

A User Friendly Toolbox for Parallel PDE-Solvers A User Friendly Toolbox for Parallel PDE-Solvers Gundolf Haase Institut for Mathematics and Scientific Computing Karl-Franzens University of Graz Manfred Liebmann Mathematics in Sciences Max-Planck-Institute

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

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

Local Mesh Refinement with the PCD Method

Local Mesh Refinement with the PCD Method Advances in Dynamical Systems and Applications ISSN 0973-5321, Volume 8, Number 1, pp. 125 136 (2013) http://campus.mst.edu/adsa Local Mesh Refinement with the PCD Method Ahmed Tahiri Université Med Premier

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

Parallel Implementation of BDDC for Mixed-Hybrid Formulation of Flow in Porous Media

Parallel Implementation of BDDC for Mixed-Hybrid Formulation of Flow in Porous Media Parallel Implementation of BDDC for Mixed-Hybrid Formulation of Flow in Porous Media Jakub Šístek1 joint work with Jan Březina 2 and Bedřich Sousedík 3 1 Institute of Mathematics of the AS CR Nečas Center

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

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

Poisson Equation in 2D

Poisson Equation in 2D A Parallel Strategy Department of Mathematics and Statistics McMaster University March 31, 2010 Outline Introduction 1 Introduction Motivation Discretization Iterative Methods 2 Additive Schwarz Method

More information

Toward black-box adaptive domain decomposition methods

Toward black-box adaptive domain decomposition methods 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)

More information

Domain decomposition for the Jacobi-Davidson method: practical strategies

Domain decomposition for the Jacobi-Davidson method: practical strategies Chapter 4 Domain decomposition for the Jacobi-Davidson method: practical strategies Abstract The Jacobi-Davidson method is an iterative method for the computation of solutions of large eigenvalue problems.

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

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

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

Solving Ax = b, an overview. Program

Solving Ax = b, an overview. Program Numerical Linear Algebra Improving iterative solvers: preconditioning, deflation, numerical software and parallelisation Gerard Sleijpen and Martin van Gijzen November 29, 27 Solving Ax = b, an overview

More information

2 FORMULATIONS 2.1 The H-J formulation Let Ω be a domain consisting of a conducting region R and a non-conducting region S. Here assume that Ω, R and

2 FORMULATIONS 2.1 The H-J formulation Let Ω be a domain consisting of a conducting region R and a non-conducting region S. Here assume that Ω, R and Annual Report of ADVENTURE Project ADV-99-1(1999) LARGE-SCALE MAGNETIC FIELD ANALYSES Hiroshi KANAYAMA Department of Intelligent Machinery and Systems Graduate School of Engineering, Kyushu University

More information

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

A Jacobi Davidson Method with a Multigrid Solver for the Hermitian Wilson-Dirac Operator

A Jacobi Davidson Method with a Multigrid Solver for the Hermitian Wilson-Dirac Operator A Jacobi Davidson Method with a Multigrid Solver for the Hermitian Wilson-Dirac Operator Artur Strebel Bergische Universität Wuppertal August 3, 2016 Joint Work This project is joint work with: Gunnar

More information

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

WRF performance tuning for the Intel Woodcrest Processor

WRF performance tuning for the Intel Woodcrest Processor WRF performance tuning for the Intel Woodcrest Processor A. Semenov, T. Kashevarova, P. Mankevich, D. Shkurko, K. Arturov, N. Panov Intel Corp., pr. ak. Lavrentieva 6/1, Novosibirsk, Russia, 630090 {alexander.l.semenov,tamara.p.kashevarova,pavel.v.mankevich,

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

Scalable Non-Linear Compact Schemes

Scalable Non-Linear Compact Schemes Scalable Non-Linear Compact Schemes Debojyoti Ghosh Emil M. Constantinescu Jed Brown Mathematics Computer Science Argonne National Laboratory International Conference on Spectral and High Order Methods

More information

Parallelization of the FE-solver ICONA

Parallelization of the FE-solver ICONA Parallelization of the FE-solver ICONA 2 nd Workshop on Structural Analysis of Lightweight Structures INTALES GmbH Engineering Solutions University of Innsbruck, Faculty of Civil Engineering Sciences University

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

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

2 CAI, KEYES AND MARCINKOWSKI proportional to the relative nonlinearity of the function; i.e., as the relative nonlinearity increases the domain of co

2 CAI, KEYES AND MARCINKOWSKI proportional to the relative nonlinearity of the function; i.e., as the relative nonlinearity increases the domain of co INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2002; 00:1 6 [Version: 2000/07/27 v1.0] Nonlinear Additive Schwarz Preconditioners and Application in Computational Fluid

More information

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers Applied and Computational Mathematics 2017; 6(4): 202-207 http://www.sciencepublishinggroup.com/j/acm doi: 10.11648/j.acm.20170604.18 ISSN: 2328-5605 (Print); ISSN: 2328-5613 (Online) A Robust Preconditioned

More information

Robust Preconditioned Conjugate Gradient for the GPU and Parallel Implementations

Robust Preconditioned Conjugate Gradient for the GPU and Parallel Implementations Robust Preconditioned Conjugate Gradient for the GPU and Parallel Implementations Rohit Gupta, Martin van Gijzen, Kees Vuik GPU Technology Conference 2012, San Jose CA. GPU Technology Conference 2012,

More information

Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations

Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations by Wilhelm Heinrichs Universität Duisburg Essen, Ingenieurmathematik Universitätsstr.

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

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

The Performance Evolution of the Parallel Ocean Program on the Cray X1

The Performance Evolution of the Parallel Ocean Program on the Cray X1 The Performance Evolution of the Parallel Ocean Program on the Cray X1 Patrick H. Worley Oak Ridge National Laboratory John Levesque Cray Inc. 46th Cray User Group Conference May 18, 2003 Knoxville Marriott

More information

Multigrid and Domain Decomposition Methods for Electrostatics Problems

Multigrid and Domain Decomposition Methods for Electrostatics Problems Multigrid and Domain Decomposition Methods for Electrostatics Problems Michael Holst and Faisal Saied Abstract. We consider multigrid and domain decomposition methods for the numerical solution of electrostatics

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

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 24: Preconditioning and Multigrid Solver Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 5 Preconditioning Motivation:

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

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

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

Uncertainty analysis of large-scale systems using domain decomposition

Uncertainty analysis of large-scale systems using domain decomposition Center for Turbulence Research Annual Research Briefs 2007 143 Uncertainty analysis of large-scale systems using domain decomposition By D. Ghosh, C. Farhat AND P. Avery 1. Motivation and objectives A

More information

A SHORT NOTE COMPARING MULTIGRID AND DOMAIN DECOMPOSITION FOR PROTEIN MODELING EQUATIONS

A SHORT NOTE COMPARING MULTIGRID AND DOMAIN DECOMPOSITION FOR PROTEIN MODELING EQUATIONS A SHORT NOTE COMPARING MULTIGRID AND DOMAIN DECOMPOSITION FOR PROTEIN MODELING EQUATIONS MICHAEL HOLST AND FAISAL SAIED Abstract. We consider multigrid and domain decomposition methods for the numerical

More information

FINE-GRAINED PARALLEL INCOMPLETE LU FACTORIZATION

FINE-GRAINED PARALLEL INCOMPLETE LU FACTORIZATION FINE-GRAINED PARALLEL INCOMPLETE LU FACTORIZATION EDMOND CHOW AND AFTAB PATEL Abstract. This paper presents a new fine-grained parallel algorithm for computing an incomplete LU factorization. All nonzeros

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

DELFT UNIVERSITY OF TECHNOLOGY

DELFT UNIVERSITY OF TECHNOLOGY DELFT UNIVERSITY OF TECHNOLOGY REPORT 09-08 Preconditioned conjugate gradient method enhanced by deflation of rigid body modes applied to composite materials. T.B. Jönsthövel ISSN 1389-6520 Reports of

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

Numerical behavior of inexact linear solvers

Numerical behavior of inexact linear solvers Numerical behavior of inexact linear solvers Miro Rozložník joint results with Zhong-zhi Bai and Pavel Jiránek Institute of Computer Science, Czech Academy of Sciences, Prague, Czech Republic The fourth

More information

Final Ph.D. Progress Report. Integration of hp-adaptivity with a Two Grid Solver: Applications to Electromagnetics. David Pardo

Final Ph.D. Progress Report. Integration of hp-adaptivity with a Two Grid Solver: Applications to Electromagnetics. David Pardo Final Ph.D. Progress Report Integration of hp-adaptivity with a Two Grid Solver: Applications to Electromagnetics. David Pardo Dissertation Committee: I. Babuska, L. Demkowicz, C. Torres-Verdin, R. Van

More information

On the interplay between discretization and preconditioning of Krylov subspace methods

On the interplay between discretization and preconditioning of Krylov subspace methods On the interplay between discretization and preconditioning of Krylov subspace methods Josef Málek and Zdeněk Strakoš Nečas Center for Mathematical Modeling Charles University in Prague and Czech Academy

More information

Parallel Algorithms for Solution of Large Sparse Linear Systems with Applications

Parallel Algorithms for Solution of Large Sparse Linear Systems with Applications Parallel Algorithms for Solution of Large Sparse Linear Systems with Applications Murat Manguoğlu Department of Computer Engineering Middle East Technical University, Ankara, Turkey Prace workshop: HPC

More information

A MULTIGRID ALGORITHM FOR. Richard E. Ewing and Jian Shen. Institute for Scientic Computation. Texas A&M University. College Station, Texas SUMMARY

A MULTIGRID ALGORITHM FOR. Richard E. Ewing and Jian Shen. Institute for Scientic Computation. Texas A&M University. College Station, Texas SUMMARY A MULTIGRID ALGORITHM FOR THE CELL-CENTERED FINITE DIFFERENCE SCHEME Richard E. Ewing and Jian Shen Institute for Scientic Computation Texas A&M University College Station, Texas SUMMARY In this article,

More information

A domain decomposition algorithm for contact problems with Coulomb s friction

A domain decomposition algorithm for contact problems with Coulomb s friction A domain decomposition algorithm for contact problems with Coulomb s friction J. Haslinger 1,R.Kučera 2, and T. Sassi 1 1 Introduction Contact problems of elasticity are used in many fields of science

More information

Scalable BETI for Variational Inequalities

Scalable BETI for Variational Inequalities Scalable BETI for Variational Inequalities Jiří Bouchala, Zdeněk Dostál and Marie Sadowská Department of Applied Mathematics, Faculty of Electrical Engineering and Computer Science, VŠB-Technical University

More information

Presentation Outline

Presentation Outline Parallel Multi-Zone Methods for Large- Scale Multidisciplinary Computational Physics Simulations Ding Li, Guoping Xia and Charles L. Merkle Purdue University The 6th International Conference on Linux Clusters

More information