A Parallel Implementation of the BDDC Method for Linear Elasticity

Size: px
Start display at page:

Download "A Parallel Implementation of the BDDC Method for Linear Elasticity"

Transcription

1 A Parallel Implementation of the BDDC Method for Linear Elasticity Jakub Šístek joint work with P. Burda, M. Čertíková, J. Mandel, J. Novotný, B. Sousedík Institute of Mathematics of the AS CR, Prague Czech Technical University, Prague University of Colorado Denver MAFELAP 2009, June 9-12, 2009 INSTITUTE of MATHEMATICS Academy of Sciences Czech Republic

2 Some motivation for domain decomposition (DD) methods very large systems of algebraic equations arising from FEM difficulties with solution by conventional numerical methods direct methods slow due to the problem size iterative methods slow due to large condition number suitable preconditioner needed combination of these approaches synergy in domain decomposition (DD) methods natural way to parallelize FEM two recent methods for elliptic PDEs BDDC and FETI-DP

3 Brief overview of BDDC method Balancing Domain Decomposition by Constraints 2003 C. Dohrmann (Sandia), theory with J. Mandel (UCD) nonoverlapping primary domain decomposition method equivalent to FETI-DP [Mandel, Dohrmann, Tezaur 2005]

4 The abstract problem Variational setting u U : a(u, v) = f, v v U a (, ) symmetric positive definite form on U, is inner product on U U is finite dimensional space Matrix form u U : Au = f A symmetric positive definite matrix on U Linked together Au, v = a (u, v) u, v U

5 BDDC set-up division into subdomains selection of coarse problem nodes (also called corners) interface subdomain Ωi coarse problem nodes h H finite elements

6 Function spaces in BDDC U W c W continuous continuous at coarse no continuity problem nodes enough coarse nodes to fix floating subdomains rigid body modes captured a (, ) symmetric positive definite form on W c corresponding matrix Ãc symmetric positive definite, almost block diagonal structure, larger dimension than A operator of projection E : W c U, Range(E) = U, e.g. averaging across interfaces (arithmetic, weighted)

7 The second intermediate space in BDDC Only coarse nodes do not suffice for optimal preconditioning in 3D additional constraints on functions from W c necessary U W W c continuous add constraints only corners Examples: equivalent averages on subsets of interface (edges, faces) across interface, additional pointwise continuity constraints

8 The BDDC preconditioner Define M BDDC : r U û U M BDDC : r û = Ew, w W : a (w, z) = r, Ez, z W r - residual in an iteration of PCG û - correction to solution (preconditioned residual)

9 The coarse space in BDDC In implementation, space W may be split into independent subdomain spaces and energy-orthogonal coarse space. On each subdomain coarse degrees of freedom basis functions Ψ i prescribed values of coarse degrees of freedom, minimal energy elsewhere, [ Ai C T i C i 0 ] [ Ψi Λ i ] = A i... local subdomain stiffness matrix [ 0 I C i... matrix of constraints selects unknowns into coarse degrees of freedom Matrix of coarse problem A C assembled from local matrices A Ci = Ψ T i A i Ψ i. ].

10 The coarse space in BDDC a function from coarse space coarse basis function

11 An iteration of BDDC 1. Residual on interface r (k) = g Sû (k) S Schur complement w.r.t. interface, g condensed r.h.s. 2. Distribution of residual local problems coarse problem for i = 1,..., N N r i = Ei T r (k) r C = RCi T ΨT i Ei T r (k) 3. Correction of solution i=1 [ Ai Ci T ] [ ] [ ] ui ri = C i 0 µ i 0 A C u C = r C 4. New approximation û = N E i (Ψ i R Ci u C + u i ), û (k+1) = û (k) + û i=1

12 Frontal solver B. M. Irons, 1970 direct solver for sparse matrices arising in FEM number of flops O(n nfron 2 ), where nfron << n is the front width memory demand nfron 2 if out-of-core element-by-element approach element matrices read from file until whole line is assembled, then immediately eliminated basic scheme block 1 - free variables, block 2 - constrained (also fixed ) variables [ A11 A 12 A 21 A 22 x 2, f 1, f 2 inputs ] [ x1 x 2 ] = [ f1 x 1, Rea 2 (reaction forces) outputs f 2 ] [ + 0 Rea 2 ], (1)

13 General constraints vs. frontal solver on subdomain central idea split matrix C according to types of constraints corners as Dirichlet boundary conditions, i.e. fixed variables averages enforced by Lagrange multipliers matrix C f coarse problem construction on subdomain (index i omitted) A ff A fc C T f A cf A cc 0 C f 0 0 Ψ c f Ψ avg f I 0 λ c λ avg = I.

14 Algorithm of preconditioner setup 1. Forward step of frontal solver with corners marked as fixed variables in matrix A. 2. Find A 1 ff C f T by backward solve by frontal solver [ ] [ Aff A fc A 1 ff C T ] [ ] [ ] f C T = f 0 + ( A cf A cc 0 0 Cf A 1 ff A ) T. fc 3. Construct C f A 1 ff C f T and factorize it by LAPACK. 4. Backward solve of dual problem by LAPACK for λ from C f A 1 ff C f T λ = [ C f A 1 ff A fc I 5. Backward solve for Ψ f by frontal solver [ ] [ Aff A fc Ψ c f Ψ avg ] [ f C T = f λ I 0 0 A cf A cc [ C 6. Compute local A C = Ψ T AΨ = Ψ T T f λ Rea ]. ] [ 0 + Rea ]. ].

15 General constraints vs. frontal solver subdomain problem solution A ff A fc Cf T A cf A cc 0 C f 0 0 u f 0 µ = r 0 0. Now single right-hand side.

16 Algorithm of preconditioning action on subdomain 1. Backward step of frontal solver for A 1 ff r [ ] [ Aff A fc A 1 r ] A cf A cc 2. Backward step of LAPACK for µ C f A 1 ff ff 0 C f T = [ r 0 µ = C f A 1 ff r. ] [ 0 + Rea ]. 3. Backward step of frontal solver for u f [ ] [ ] [ Aff A fc uf C T = f µ + r 0 0 A cf A cc ] [ 0 + Rea ].

17 Implementation subdomain problems - frontal solver + LAPACK coarse problem - MUltifrontal Massively Parallel sparse direct Solver (MUMPS) mainly Fortran 77 programming language, partly Fortran 90, MPI library tested on SGI Altix 4700, CTU, Prague, CR 72 processors Intel Itanium 2, OS Linux

18 Hip joint replacement I quadratic elements, unknowns I 16 subdomains, 35 corners, 12 edges, and 35 faces I 32 subdomains, 57 corners, 12 edges, and 66 faces I 16 processors of SGI Altix 4700 Decomposition into 32 subdomains

19 Hip joint replacement von Mises stresses in improved design

20 Hip joint replacement 100 Condition number SGI Altix processors nsub = 16 nsub = condition number estimate [/] number of corners [/] Condition number for adding corners

21 Hip joint replacement Wall times for variable coarse problem SGI Altix processors nsub = 16 nsub = wall time [seconds] number of corners [/] Wall clock time for adding corners

22 Hip joint replacement, 16 subdomains coarse problem C. C.+E. C.+F. C.+E.+F. iterations cond. number est factorization (sec) pcg iter (sec) total (sec) coarse degrees of freedom: C. - Corners only adding averages to 335 corners C.+E. - Corners and averages on Edges C.+F. - Corners and averages on Faces C.+E.+F. - Corners and averages on Edges and Faces

23 Hip joint replacement, 32 subdomains coarse problem C. C.+E. C.+F. C.+E.+F. iterations cond. number est factorization (sec) pcg iter (sec) total (sec) coarse degrees of freedom: C. - Corners only adding averages to 557 corners C.+E. - Corners and averages on Edges C.+F. - Corners and averages on Faces C.+E.+F. - Corners and averages on Edges and Faces

24 Conclusion distinguish between point constraints and averages for frontal solver many matrices needed in BDDC simple side-product of frontal solver (reactions) minimal number of corners does not assure minimal solution time constraits on edges and/or faces can considerably shorten the solution time more sophisticated (adaptive) way for selection of constraints - ongoing research

Approaches to Parallel Implementation of the BDDC Method

Approaches to Parallel Implementation of the BDDC Method Approaches to Parallel Implementation of the BDDC Method Jakub Šístek Includes joint work with P. Burda, M. Čertíková, J. Mandel, J. Novotný, B. Sousedík. Institute of Mathematics of the AS CR, Prague

More information

Primal methods of iterative substructuring

Primal methods of iterative substructuring Primal methods of iterative substructuring Jakub Šístek Institute of Mathematics of the AS CR, Prague Programs and Algorithms of Numerical Mathematics 16 June 5th, 2012 Co-workers Presentation based on

More information

arxiv: v2 [math.na] 19 Mar 2011

arxiv: v2 [math.na] 19 Mar 2011 Face-based Selection of Corners in 3D Substructuring Jakub Šísteka,, Marta Čertíkováb, Pavel Burda b, Jaroslav Novotný c arxiv:0911.1245v2 [math.na] 19 Mar 2011 Abstract a Institute of Mathematics, Academy

More information

The effect of irregular interfaces on the BDDC method for the Navier-Stokes equations

The effect of irregular interfaces on the BDDC method for the Navier-Stokes equations 153 The effect of irregular interfaces on the BDDC method for the Navier-Stokes equations Martin Hanek 1, Jakub Šístek 2,3 and Pavel Burda 1 1 Introduction The Balancing Domain Decomposition based on Constraints

More information

arxiv: v2 [math.na] 15 May 2010

arxiv: v2 [math.na] 15 May 2010 Coarse spaces over the ages arxiv:0911.5725v2 [math.na] 15 May 2010 Jan Mandel 1 and Bedřich Sousedík 1,2 1 Department of Mathematical and Statistical Sciences, University of Colorado Denver, Campus Box

More information

BDDCML. solver library based on Multi-Level Balancing Domain Decomposition by Constraints copyright (C) Jakub Šístek version 1.

BDDCML. solver library based on Multi-Level Balancing Domain Decomposition by Constraints copyright (C) Jakub Šístek version 1. BDDCML solver library based on Multi-Level Balancing Domain Decomposition by Constraints copyright (C) 2010-2012 Jakub Šístek version 1.3 Jakub Šístek i Table of Contents 1 Introduction.....................................

More information

Contents. I The Basic Framework for Stationary Problems 1

Contents. I The Basic Framework for Stationary Problems 1 page v Preface xiii I The Basic Framework for Stationary Problems 1 1 Some model PDEs 3 1.1 Laplace s equation; elliptic BVPs... 3 1.1.1 Physical experiments modeled by Laplace s equation... 5 1.2 Other

More information

Some Computational Results for Dual-Primal FETI Methods for Elliptic Problems in 3D

Some Computational Results for Dual-Primal FETI Methods for Elliptic Problems in 3D Some Computational Results for Dual-Primal FETI Methods for Elliptic Problems in 3D Axel Klawonn 1, Oliver Rheinbach 1, and Olof B. Widlund 2 1 Universität Duisburg-Essen, Campus Essen, Fachbereich Mathematik

More information

Elliptic model problem, finite elements, and geometry

Elliptic model problem, finite elements, and geometry Thirteenth International Conference on Domain Decomposition Methods Editors: N. Debit, M.Garbey, R. Hoppe, J. Périaux, D. Keyes, Y. Kuznetsov c 200 DDM.org 4 FETI-DP Methods for Elliptic Problems with

More information

THE MORTAR FINITE ELEMENT METHOD IN 2D: IMPLEMENTATION IN MATLAB

THE MORTAR FINITE ELEMENT METHOD IN 2D: IMPLEMENTATION IN MATLAB THE MORTAR FINITE ELEMENT METHOD IN D: IMPLEMENTATION IN MATLAB J. Daněk, H. Kutáková Department of Mathematics, University of West Bohemia, Pilsen MECAS ESI s.r.o., Pilsen Abstract The paper is focused

More information

Scheduling Strategies for Parallel Sparse Backward/Forward Substitution

Scheduling Strategies for Parallel Sparse Backward/Forward Substitution Scheduling Strategies for Parallel Sparse Backward/Forward Substitution J.I. Aliaga M. Bollhöfer A.F. Martín E.S. Quintana-Ortí Deparment of Computer Science and Engineering, Univ. Jaume I (Spain) {aliaga,martina,quintana}@icc.uji.es

More information

SCALABLE ALGORITHMS for solving large sparse linear systems of equations

SCALABLE ALGORITHMS for solving large sparse linear systems of equations SCALABLE ALGORITHMS for solving large sparse linear systems of equations CONTENTS Sparse direct solvers (multifrontal) Substructuring methods (hybrid solvers) Jacko Koster, Bergen Center for Computational

More information

ME964 High Performance Computing for Engineering Applications

ME964 High Performance Computing for Engineering Applications ME964 High Performance Computing for Engineering Applications Outlining Midterm Projects Topic 3: GPU-based FEA Topic 4: GPU Direct Solver for Sparse Linear Algebra March 01, 2011 Dan Negrut, 2011 ME964

More information

smooth coefficients H. Köstler, U. Rüde

smooth coefficients H. Köstler, U. Rüde A robust multigrid solver for the optical flow problem with non- smooth coefficients H. Köstler, U. Rüde Overview Optical Flow Problem Data term and various regularizers A Robust Multigrid Solver Galerkin

More information

Null space computation of sparse singular matrices with MUMPS

Null space computation of sparse singular matrices with MUMPS Null space computation of sparse singular matrices with MUMPS Xavier Vasseur (CERFACS) In collaboration with Patrick Amestoy (INPT-IRIT, University of Toulouse and ENSEEIHT), Serge Gratton (INPT-IRIT,

More information

The numerical simulation of complex PDE problems. A numerical simulation project The finite element method for solving a boundary-value problem in R 2

The numerical simulation of complex PDE problems. A numerical simulation project The finite element method for solving a boundary-value problem in R 2 Universidad de Chile The numerical simulation of complex PDE problems Facultad de Ciencias Físicas y Matemáticas P. Frey, M. De Buhan Year 2008 MA691 & CC60X A numerical simulation project The finite element

More information

PROGRAMMING OF MULTIGRID METHODS

PROGRAMMING OF MULTIGRID METHODS PROGRAMMING OF MULTIGRID METHODS LONG CHEN In this note, we explain the implementation detail of multigrid methods. We will use the approach by space decomposition and subspace correction method; see Chapter:

More information

Preparation of Codes for Trinity

Preparation of Codes for Trinity Preparation of Codes for Trinity Courtenay T. Vaughan, Mahesh Rajan, Dennis C. Dinge, Clark R. Dohrmann, Micheal W. Glass, Kenneth J. Franko, Kendall H. Pierson, and Michael R. Tupek Sandia National Laboratories

More information

GRAPH CENTERS USED FOR STABILIZATION OF MATRIX FACTORIZATIONS

GRAPH CENTERS USED FOR STABILIZATION OF MATRIX FACTORIZATIONS Discussiones Mathematicae Graph Theory 30 (2010 ) 349 359 GRAPH CENTERS USED FOR STABILIZATION OF MATRIX FACTORIZATIONS Pavla Kabelíková Department of Applied Mathematics FEI, VSB Technical University

More information

Advanced Numerical Techniques for Cluster Computing

Advanced Numerical Techniques for Cluster Computing Advanced Numerical Techniques for Cluster Computing Presented by Piotr Luszczek http://icl.cs.utk.edu/iter-ref/ Presentation Outline Motivation hardware Dense matrix calculations Sparse direct solvers

More information

On Level Scheduling for Incomplete LU Factorization Preconditioners on Accelerators

On Level Scheduling for Incomplete LU Factorization Preconditioners on Accelerators On Level Scheduling for Incomplete LU Factorization Preconditioners on Accelerators Karl Rupp, Barry Smith rupp@mcs.anl.gov Mathematics and Computer Science Division Argonne National Laboratory FEMTEC

More information

Parallel implementation of Total-FETI DDM with application to medical image registration

Parallel implementation of Total-FETI DDM with application to medical image registration Parallel implementation of Total-FETI DDM with application to medical image registration Michal Merta 1, Alena Vašatová 1, Václav Hapla 1, and David Horák 1 Key words: Total-FETI, image registration, parallel

More information

FETI Coarse Problem Parallelization Strategies and Their Comparison

FETI Coarse Problem Parallelization Strategies and Their Comparison Available on-line at www.prace-ri.eu Partnership for Advanced Computing in Europe FETI Coarse Problem Parallelization Strategies and Their Comparison T. Kozubek a,, D. Horak a, V. Hapla a a CE IT4Innovations,

More information

Parallel High-Order Geometric Multigrid Methods on Adaptive Meshes for Highly Heterogeneous Nonlinear Stokes Flow Simulations of Earth s Mantle

Parallel High-Order Geometric Multigrid Methods on Adaptive Meshes for Highly Heterogeneous Nonlinear Stokes Flow Simulations of Earth s Mantle ICES Student Forum The University of Texas at Austin, USA November 4, 204 Parallel High-Order Geometric Multigrid Methods on Adaptive Meshes for Highly Heterogeneous Nonlinear Stokes Flow Simulations of

More information

Study and implementation of computational methods for Differential Equations in heterogeneous systems. Asimina Vouronikoy - Eleni Zisiou

Study and implementation of computational methods for Differential Equations in heterogeneous systems. Asimina Vouronikoy - Eleni Zisiou Study and implementation of computational methods for Differential Equations in heterogeneous systems Asimina Vouronikoy - Eleni Zisiou Outline Introduction Review of related work Cyclic Reduction Algorithm

More information

The 3D DSC in Fluid Simulation

The 3D DSC in Fluid Simulation The 3D DSC in Fluid Simulation Marek K. Misztal Informatics and Mathematical Modelling, Technical University of Denmark mkm@imm.dtu.dk DSC 2011 Workshop Kgs. Lyngby, 26th August 2011 Governing Equations

More information

2 Fundamentals of Serial Linear Algebra

2 Fundamentals of Serial Linear Algebra . Direct Solution of Linear Systems.. Gaussian Elimination.. LU Decomposition and FBS..3 Cholesky Decomposition..4 Multifrontal Methods. Iterative Solution of Linear Systems.. Jacobi Method Fundamentals

More information

A parallel direct/iterative solver based on a Schur complement approach

A parallel direct/iterative solver based on a Schur complement approach A parallel direct/iterative solver based on a Schur complement approach Gene around the world at CERFACS Jérémie Gaidamour LaBRI and INRIA Bordeaux - Sud-Ouest (ScAlApplix project) February 29th, 2008

More information

Transaction of JSCES, Paper No Parallel Finite Element Analysis in Large Scale Shell Structures using CGCG Solver

Transaction of JSCES, Paper No Parallel Finite Element Analysis in Large Scale Shell Structures using CGCG Solver Transaction of JSCES, Paper No. 257 * Parallel Finite Element Analysis in Large Scale Shell Structures using Solver 1 2 3 Shohei HORIUCHI, Hirohisa NOGUCHI and Hiroshi KAWAI 1 24-62 22-4 2 22 3-14-1 3

More information

Speedup Altair RADIOSS Solvers Using NVIDIA GPU

Speedup Altair RADIOSS Solvers Using NVIDIA GPU Innovation Intelligence Speedup Altair RADIOSS Solvers Using NVIDIA GPU Eric LEQUINIOU, HPC Director Hongwei Zhou, Senior Software Developer May 16, 2012 Innovation Intelligence ALTAIR OVERVIEW Altair

More information

ESPRESO ExaScale PaRallel FETI Solver. Hybrid FETI Solver Report

ESPRESO ExaScale PaRallel FETI Solver. Hybrid FETI Solver Report ESPRESO ExaScale PaRallel FETI Solver Hybrid FETI Solver Report Lubomir Riha, Tomas Brzobohaty IT4Innovations Outline HFETI theory from FETI to HFETI communication hiding and avoiding techniques our new

More information

Using multifrontal hierarchically solver and HPC systems for 3D Helmholtz problem

Using multifrontal hierarchically solver and HPC systems for 3D Helmholtz problem Using multifrontal hierarchically solver and HPC systems for 3D Helmholtz problem Sergey Solovyev 1, Dmitry Vishnevsky 1, Hongwei Liu 2 Institute of Petroleum Geology and Geophysics SB RAS 1 EXPEC ARC,

More information

Parallel resolution of sparse linear systems by mixing direct and iterative methods

Parallel resolution of sparse linear systems by mixing direct and iterative methods Parallel resolution of sparse linear systems by mixing direct and iterative methods Phyleas Meeting, Bordeaux J. Gaidamour, P. Hénon, J. Roman, Y. Saad LaBRI and INRIA Bordeaux - Sud-Ouest (ScAlApplix

More information

The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems. Prof. Dr. Eleni Chatzi, J.P. Escallo n Lecture December, 2013

The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems. Prof. Dr. Eleni Chatzi, J.P. Escallo n Lecture December, 2013 The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems Prof. Dr. Eleni Chatzi, J.P. Escallo n Lecture 11-17 December, 2013 Institute of Structural Engineering Method of Finite Elements

More information

problems on. Of course, additional interface conditions must be

problems on. Of course, additional interface conditions must be Thirteenth International Conference on Domain Decomposition Methods Editors: N. Debit, M.Garbey, R. Hoppe, J. Périaux, D. Keyes, Y. Kuznetsov c 2001 DDM.org 53 Schur Complement Based Preconditioners for

More information

Multi-GPU Scaling of Direct Sparse Linear System Solver for Finite-Difference Frequency-Domain Photonic Simulation

Multi-GPU Scaling of Direct Sparse Linear System Solver for Finite-Difference Frequency-Domain Photonic Simulation Multi-GPU Scaling of Direct Sparse Linear System Solver for Finite-Difference Frequency-Domain Photonic Simulation 1 Cheng-Han Du* I-Hsin Chung** Weichung Wang* * I n s t i t u t e o f A p p l i e d M

More information

SUMMARY. solve the matrix system using iterative solvers. We use the MUMPS codes and distribute the computation over many different

SUMMARY. solve the matrix system using iterative solvers. We use the MUMPS codes and distribute the computation over many different Forward Modelling and Inversion of Multi-Source TEM Data D. W. Oldenburg 1, E. Haber 2, and R. Shekhtman 1 1 University of British Columbia, Department of Earth & Ocean Sciences 2 Emory University, Atlanta,

More information

Revision of the SolidWorks Variable Pressure Simulation Tutorial J.E. Akin, Rice University, Mechanical Engineering. Introduction

Revision of the SolidWorks Variable Pressure Simulation Tutorial J.E. Akin, Rice University, Mechanical Engineering. Introduction Revision of the SolidWorks Variable Pressure Simulation Tutorial J.E. Akin, Rice University, Mechanical Engineering Introduction A SolidWorks simulation tutorial is just intended to illustrate where to

More information

AMS527: Numerical Analysis II

AMS527: Numerical Analysis II AMS527: Numerical Analysis II A Brief Overview of Finite Element Methods Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao SUNY Stony Brook AMS527: Numerical Analysis II 1 / 25 Overview Basic concepts Mathematical

More information

Efficient Finite Element Geometric Multigrid Solvers for Unstructured Grids on GPUs

Efficient Finite Element Geometric Multigrid Solvers for Unstructured Grids on GPUs Efficient Finite Element Geometric Multigrid Solvers for Unstructured Grids on GPUs Markus Geveler, Dirk Ribbrock, Dominik Göddeke, Peter Zajac, Stefan Turek Institut für Angewandte Mathematik TU Dortmund,

More information

Massively Parallel Finite Element Simulations with deal.ii

Massively Parallel Finite Element Simulations with deal.ii Massively Parallel Finite Element Simulations with deal.ii Timo Heister, Texas A&M University 2012-02-16 SIAM PP2012 joint work with: Wolfgang Bangerth, Carsten Burstedde, Thomas Geenen, Martin Kronbichler

More information

Parallel FEM Computation and Multilevel Graph Partitioning Xing Cai

Parallel FEM Computation and Multilevel Graph Partitioning Xing Cai Parallel FEM Computation and Multilevel Graph Partitioning Xing Cai Simula Research Laboratory Overview Parallel FEM computation how? Graph partitioning why? The multilevel approach to GP A numerical example

More information

HIPS : a parallel hybrid direct/iterative solver based on a Schur complement approach

HIPS : a parallel hybrid direct/iterative solver based on a Schur complement approach HIPS : a parallel hybrid direct/iterative solver based on a Schur complement approach Mini-workshop PHyLeaS associated team J. Gaidamour, P. Hénon July 9, 28 HIPS : an hybrid direct/iterative solver /

More information

Performance Comparison between Blocking and Non-Blocking Communications for a Three-Dimensional Poisson Problem

Performance Comparison between Blocking and Non-Blocking Communications for a Three-Dimensional Poisson Problem Performance Comparison between Blocking and Non-Blocking Communications for a Three-Dimensional Poisson Problem Guan Wang and Matthias K. Gobbert Department of Mathematics and Statistics, University of

More information

Netgen/NGSolve Tutorial Part 3 - Programming with Netgen/NGSolve

Netgen/NGSolve Tutorial Part 3 - Programming with Netgen/NGSolve Netgen/NGSolve Tutorial Part 3 - Programming with Netgen/NGSolve March 24, 2015 Outline Introduction Some NGSolve basic s my_little_ngsolve Numerical procedures Files and Tasks Overview Aim of tutorial

More information

GPU Cluster Computing for FEM

GPU Cluster Computing for FEM GPU Cluster Computing for FEM Dominik Göddeke Sven H.M. Buijssen, Hilmar Wobker and Stefan Turek Angewandte Mathematik und Numerik TU Dortmund, Germany dominik.goeddeke@math.tu-dortmund.de GPU Computing

More information

A NEW MIXED PRECONDITIONING METHOD BASED ON THE CLUSTERED ELEMENT -BY -ELEMENT PRECONDITIONERS

A NEW MIXED PRECONDITIONING METHOD BASED ON THE CLUSTERED ELEMENT -BY -ELEMENT PRECONDITIONERS Contemporary Mathematics Volume 157, 1994 A NEW MIXED PRECONDITIONING METHOD BASED ON THE CLUSTERED ELEMENT -BY -ELEMENT PRECONDITIONERS T.E. Tezduyar, M. Behr, S.K. Aliabadi, S. Mittal and S.E. Ray ABSTRACT.

More information

Introduction to Parallel Computing

Introduction to Parallel Computing Introduction to Parallel Computing W. P. Petersen Seminar for Applied Mathematics Department of Mathematics, ETHZ, Zurich wpp@math. ethz.ch P. Arbenz Institute for Scientific Computing Department Informatik,

More information

Radek Tezaur. Senior Research Engineer at Stanford University (2011-present) Research Associate at Stanford University (2004-present)

Radek Tezaur. Senior Research Engineer at Stanford University (2011-present) Research Associate at Stanford University (2004-present) Radek Tezaur Aeronautics and Astronautics Stanford University Stanford, CA 94305 Phone: (650)725-9646 (office) Fax: (650) 723-0279 Email: rtezaur@stanford.edu Education Ph.D., Applied Mathematics, University

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 20: Sparse Linear Systems; Direct Methods vs. Iterative Methods Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 26

More information

Engineering Effects of Boundary Conditions (Fixtures and Temperatures) J.E. Akin, Rice University, Mechanical Engineering

Engineering Effects of Boundary Conditions (Fixtures and Temperatures) J.E. Akin, Rice University, Mechanical Engineering Engineering Effects of Boundary Conditions (Fixtures and Temperatures) J.E. Akin, Rice University, Mechanical Engineering Here SolidWorks stress simulation tutorials will be re-visited to show how they

More information

Modelling and Simulation of Complex GeoTechnical Problems

Modelling and Simulation of Complex GeoTechnical Problems Modelling and Simulation of Complex GeoTechnical Problems R. Blaheta Institute of Geonics AS CR, v.v.i., Ostrava, Czech Republic 1 Introduction This paper provides three examples of topical geotechnical

More information

High Performance Computing: Tools and Applications

High Performance Computing: Tools and Applications High Performance Computing: Tools and Applications Edmond Chow School of Computational Science and Engineering Georgia Institute of Technology Lecture 15 Numerically solve a 2D boundary value problem Example:

More information

Outline. Parallel Algorithms for Linear Algebra. Number of Processors and Problem Size. Speedup and Efficiency

Outline. Parallel Algorithms for Linear Algebra. Number of Processors and Problem Size. Speedup and Efficiency 1 2 Parallel Algorithms for Linear Algebra Richard P. Brent Computer Sciences Laboratory Australian National University Outline Basic concepts Parallel architectures Practical design issues Programming

More information

Numerical methods for volume preserving image registration

Numerical methods for volume preserving image registration Numerical methods for volume preserving image registration SIAM meeting on imaging science 2004 Eldad Haber with J. Modersitzki haber@mathcs.emory.edu Emory University Volume preserving IR p.1/?? Outline

More information

Solving large systems on HECToR using the 2-lagrange multiplier methods Karangelis, Anastasios; Loisel, Sebastien; Maynard, Chris

Solving large systems on HECToR using the 2-lagrange multiplier methods Karangelis, Anastasios; Loisel, Sebastien; Maynard, Chris Heriot-Watt University Heriot-Watt University Research Gateway Solving large systems on HECToR using the 2-lagrange multiplier methods Karangelis, Anastasios; Loisel, Sebastien; Maynard, Chris Published

More information

Towards a complete FEM-based simulation toolkit on GPUs: Geometric Multigrid solvers

Towards a complete FEM-based simulation toolkit on GPUs: Geometric Multigrid solvers Towards a complete FEM-based simulation toolkit on GPUs: Geometric Multigrid solvers Markus Geveler, Dirk Ribbrock, Dominik Göddeke, Peter Zajac, Stefan Turek Institut für Angewandte Mathematik TU Dortmund,

More information

GPU Acceleration of Unmodified CSM and CFD Solvers

GPU Acceleration of Unmodified CSM and CFD Solvers GPU Acceleration of Unmodified CSM and CFD Solvers Dominik Göddeke Sven H.M. Buijssen, Hilmar Wobker and Stefan Turek Angewandte Mathematik und Numerik TU Dortmund, Germany dominik.goeddeke@math.tu-dortmund.de

More information

LS-DYNA s Linear Solver Development Phase 2: Linear Solution Sequence

LS-DYNA s Linear Solver Development Phase 2: Linear Solution Sequence LS-DYNA s Linear Solver Development Phase 2: Linear Solution Sequence Allen T. Li 1, Zhe Cui 2, Yun Huang 2 1 Ford Motor Company 2 Livermore Software Technology Corporation Abstract This paper continues

More information

Preconditioning Linear Systems Arising from Graph Laplacians of Complex Networks

Preconditioning Linear Systems Arising from Graph Laplacians of Complex Networks Preconditioning Linear Systems Arising from Graph Laplacians of Complex Networks Kevin Deweese 1 Erik Boman 2 1 Department of Computer Science University of California, Santa Barbara 2 Scalable Algorithms

More information

A direct solver with reutilization of previously-computed LU factorizations for h-adaptive finite element grids with point singularities

A direct solver with reutilization of previously-computed LU factorizations for h-adaptive finite element grids with point singularities Maciej Paszynski AGH University of Science and Technology Faculty of Computer Science, Electronics and Telecommunication Department of Computer Science al. A. Mickiewicza 30 30-059 Krakow, Poland tel.

More information

Application of A Priori Error Estimates for Navier-Stokes Equations to Accurate Finite Element Solution

Application of A Priori Error Estimates for Navier-Stokes Equations to Accurate Finite Element Solution Application of A Priori Error Estimates for Navier-Stokes Equations to Accurate Finite Element Solution P. BURDA a,, J. NOVOTNÝ b,, J. ŠÍSTE a, a Department of Mathematics Czech University of Technology

More information

Ilya Lashuk, Merico Argentati, Evgenii Ovtchinnikov, Andrew Knyazev (speaker)

Ilya Lashuk, Merico Argentati, Evgenii Ovtchinnikov, Andrew Knyazev (speaker) Ilya Lashuk, Merico Argentati, Evgenii Ovtchinnikov, Andrew Knyazev (speaker) Department of Mathematics and Center for Computational Mathematics University of Colorado at Denver SIAM Conference on Parallel

More information

EFFICIENT SOLVER FOR LINEAR ALGEBRAIC EQUATIONS ON PARALLEL ARCHITECTURE USING MPI

EFFICIENT SOLVER FOR LINEAR ALGEBRAIC EQUATIONS ON PARALLEL ARCHITECTURE USING MPI EFFICIENT SOLVER FOR LINEAR ALGEBRAIC EQUATIONS ON PARALLEL ARCHITECTURE USING MPI 1 Akshay N. Panajwar, 2 Prof.M.A.Shah Department of Computer Science and Engineering, Walchand College of Engineering,

More information

Performance of Implicit Solver Strategies on GPUs

Performance of Implicit Solver Strategies on GPUs 9. LS-DYNA Forum, Bamberg 2010 IT / Performance Performance of Implicit Solver Strategies on GPUs Prof. Dr. Uli Göhner DYNAmore GmbH Stuttgart, Germany Abstract: The increasing power of GPUs can be used

More information

GPU COMPUTING WITH MSC NASTRAN 2013

GPU COMPUTING WITH MSC NASTRAN 2013 SESSION TITLE WILL BE COMPLETED BY MSC SOFTWARE GPU COMPUTING WITH MSC NASTRAN 2013 Srinivas Kodiyalam, NVIDIA, Santa Clara, USA THEME Accelerated computing with GPUs SUMMARY Current trends in HPC (High

More information

Netgen/NGSolve Tutorial Part 3 - Programming with Netgen/NGSolve

Netgen/NGSolve Tutorial Part 3 - Programming with Netgen/NGSolve Netgen/NGSolve Tutorial Part 3 - Programming with Netgen/NGSolve Christoph Lehrenfeld March 24, 2015 Contents 1 Introduction 1 2 Some NGSolve basic s 2 3 my_little_ngsolve 6 4 Numerical procedures 12 5

More information

FOR P3: A monolithic multigrid FEM solver for fluid structure interaction

FOR P3: A monolithic multigrid FEM solver for fluid structure interaction FOR 493 - P3: A monolithic multigrid FEM solver for fluid structure interaction Stefan Turek 1 Jaroslav Hron 1,2 Hilmar Wobker 1 Mudassar Razzaq 1 1 Institute of Applied Mathematics, TU Dortmund, Germany

More information

Cost-Effective Parallel Computational Electromagnetic Modeling

Cost-Effective Parallel Computational Electromagnetic Modeling Cost-Effective Parallel Computational Electromagnetic Modeling, Tom Cwik {Daniel.S.Katz, cwik}@jpl.nasa.gov Beowulf System at PL (Hyglac) l 16 Pentium Pro PCs, each with 2.5 Gbyte disk, 128 Mbyte memory,

More information

Distributed Schur Complement Solvers for Real and Complex Block-Structured CFD Problems

Distributed Schur Complement Solvers for Real and Complex Block-Structured CFD Problems Distributed Schur Complement Solvers for Real and Complex Block-Structured CFD Problems Dr.-Ing. Achim Basermann, Dr. Hans-Peter Kersken German Aerospace Center (DLR) Simulation- and Software Technology

More information

FORMING SIMULATION USING RIGID-PLASTIC MATERIAL MODEL IN MARC

FORMING SIMULATION USING RIGID-PLASTIC MATERIAL MODEL IN MARC SESSION TITLE WILL BE COMPLETED BY MSC SOFTWARE FORMING SIMULATION USING RIGID-PLASTIC MATERIAL MODEL IN MARC Gary Huang, Simufact-Americas LLC April 8, 2013 SUMMARY When simulating large deformation in

More information

A Finite Element Method for Deformable Models

A Finite Element Method for Deformable Models A Finite Element Method for Deformable Models Persephoni Karaolani, G.D. Sullivan, K.D. Baker & M.J. Baines Intelligent Systems Group, Department of Computer Science University of Reading, RG6 2AX, UK,

More information

Figure 6.1: Truss topology optimization diagram.

Figure 6.1: Truss topology optimization diagram. 6 Implementation 6.1 Outline This chapter shows the implementation details to optimize the truss, obtained in the ground structure approach, according to the formulation presented in previous chapters.

More information

Application of GPU-Based Computing to Large Scale Finite Element Analysis of Three-Dimensional Structures

Application of GPU-Based Computing to Large Scale Finite Element Analysis of Three-Dimensional Structures Paper 6 Civil-Comp Press, 2012 Proceedings of the Eighth International Conference on Engineering Computational Technology, B.H.V. Topping, (Editor), Civil-Comp Press, Stirlingshire, Scotland Application

More information

A comparison of Algorithms for Sparse Matrix. Real-time Multibody Dynamic Simulation

A comparison of Algorithms for Sparse Matrix. Real-time Multibody Dynamic Simulation A comparison of Algorithms for Sparse Matrix Factoring and Variable Reordering aimed at Real-time Multibody Dynamic Simulation Jose-Luis Torres-Moreno, Jose-Luis Blanco, Javier López-Martínez, Antonio

More information

LECTURE 13: SOLUTION METHODS FOR CONSTRAINED OPTIMIZATION. 1. Primal approach 2. Penalty and barrier methods 3. Dual approach 4. Primal-dual approach

LECTURE 13: SOLUTION METHODS FOR CONSTRAINED OPTIMIZATION. 1. Primal approach 2. Penalty and barrier methods 3. Dual approach 4. Primal-dual approach LECTURE 13: SOLUTION METHODS FOR CONSTRAINED OPTIMIZATION 1. Primal approach 2. Penalty and barrier methods 3. Dual approach 4. Primal-dual approach Basic approaches I. Primal Approach - Feasible Direction

More information

Coupled analysis of material flow and die deflection in direct aluminum extrusion

Coupled analysis of material flow and die deflection in direct aluminum extrusion Coupled analysis of material flow and die deflection in direct aluminum extrusion W. Assaad and H.J.M.Geijselaers Materials innovation institute, The Netherlands w.assaad@m2i.nl Faculty of Engineering

More information

Chapter 1 Introduction

Chapter 1 Introduction Chapter 1 Introduction GTU Paper Analysis (New Syllabus) Sr. No. Questions 26/10/16 11/05/16 09/05/16 08/12/15 Theory 1. What is graphic standard? Explain different CAD standards. 2. Write Bresenham s

More information

Finite element method - tutorial no. 1

Finite element method - tutorial no. 1 Martin NESLÁDEK Faculty of mechanical engineering, CTU in Prague 11th October 2017 1 / 22 Introduction to the tutorials E-mail: martin.nesladek@fs.cvut.cz Room no. 622 (6th floor - Dept. of mechanics,

More information

Research Article A PETSc-Based Parallel Implementation of Finite Element Method for Elasticity Problems

Research Article A PETSc-Based Parallel Implementation of Finite Element Method for Elasticity Problems Mathematical Problems in Engineering Volume 2015, Article ID 147286, 7 pages http://dx.doi.org/10.1155/2015/147286 Research Article A PETSc-Based Parallel Implementation of Finite Element Method for Elasticity

More information

CE371 Structural Analysis II Lecture 5:

CE371 Structural Analysis II Lecture 5: CE371 Structural Analysis II Lecture 5: 15.1 15.4 15.1) Preliminary Remarks 15.2) Beam-Member Stiffness Matrix 15.3) Beam-Structure Stiffness Matrix 15.4) Application of the Stiffness Matrix. 15.1) Preliminary

More information

CMSC 714 Lecture 6 MPI vs. OpenMP and OpenACC. Guest Lecturer: Sukhyun Song (original slides by Alan Sussman)

CMSC 714 Lecture 6 MPI vs. OpenMP and OpenACC. Guest Lecturer: Sukhyun Song (original slides by Alan Sussman) CMSC 714 Lecture 6 MPI vs. OpenMP and OpenACC Guest Lecturer: Sukhyun Song (original slides by Alan Sussman) Parallel Programming with Message Passing and Directives 2 MPI + OpenMP Some applications can

More information

Parallel Mesh Partitioning in Alya

Parallel Mesh Partitioning in Alya Available online at www.prace-ri.eu Partnership for Advanced Computing in Europe Parallel Mesh Partitioning in Alya A. Artigues a *** and G. Houzeaux a* a Barcelona Supercomputing Center ***antoni.artigues@bsc.es

More information

Automated Finite Element Computations in the FEniCS Framework using GPUs

Automated Finite Element Computations in the FEniCS Framework using GPUs Automated Finite Element Computations in the FEniCS Framework using GPUs Florian Rathgeber (f.rathgeber10@imperial.ac.uk) Advanced Modelling and Computation Group (AMCG) Department of Earth Science & Engineering

More information

Precise FEM solution of corner singularity using adjusted mesh applied to 2D flow

Precise FEM solution of corner singularity using adjusted mesh applied to 2D flow Precise FEM solution of corner singularity using adjusted mesh applied to 2D flow Jakub Šístek, Pavel Burda, Jaroslav Novotný Department of echnical Mathematics, Czech echnical University in Prague, Faculty

More information

Toward robust hybrid parallel sparse solvers for large scale applications

Toward robust hybrid parallel sparse solvers for large scale applications Toward robust hybrid parallel sparse solvers for large scale applications Luc Giraud (INPT/INRIA) joint work with Azzam Haidar (CERFACS-INPT/IRIT) and Jean Roman (ENSEIRB, LaBRI and INRIA) 1st workshop

More information

Lecture 15: More Iterative Ideas

Lecture 15: More Iterative Ideas Lecture 15: More Iterative Ideas David Bindel 15 Mar 2010 Logistics HW 2 due! Some notes on HW 2. Where we are / where we re going More iterative ideas. Intro to HW 3. More HW 2 notes See solution code!

More information

CHAPTER 1. Introduction

CHAPTER 1. Introduction ME 475: Computer-Aided Design of Structures 1-1 CHAPTER 1 Introduction 1.1 Analysis versus Design 1.2 Basic Steps in Analysis 1.3 What is the Finite Element Method? 1.4 Geometrical Representation, Discretization

More information

Andrew V. Knyazev and Merico E. Argentati (speaker)

Andrew V. Knyazev and Merico E. Argentati (speaker) 1 Andrew V. Knyazev and Merico E. Argentati (speaker) Department of Mathematics and Center for Computational Mathematics University of Colorado at Denver 2 Acknowledgement Supported by Lawrence Livermore

More information

Second Conference on Parallel, Distributed, Grid and Cloud Computing for Engineering

Second Conference on Parallel, Distributed, Grid and Cloud Computing for Engineering State of the art distributed parallel computational techniques in industrial finite element analysis Second Conference on Parallel, Distributed, Grid and Cloud Computing for Engineering Ajaccio, France

More information

Early Experiences with Trinity - The First Advanced Technology Platform for the ASC Program

Early Experiences with Trinity - The First Advanced Technology Platform for the ASC Program Early Experiences with Trinity - The First Advanced Technology Platform for the ASC Program C.T. Vaughan, D.C. Dinge, P.T. Lin, S.D. Hammond, J. Cook, C. R. Trott, A.M. Agelastos, D.M. Pase, R.E. Benner,

More information

Numerical Methods to Solve 2-D and 3-D Elliptic Partial Differential Equations Using Matlab on the Cluster maya

Numerical Methods to Solve 2-D and 3-D Elliptic Partial Differential Equations Using Matlab on the Cluster maya Numerical Methods to Solve 2-D and 3-D Elliptic Partial Differential Equations Using Matlab on the Cluster maya David Stonko, Samuel Khuvis, and Matthias K. Gobbert (gobbert@umbc.edu) Department of Mathematics

More information

Simulating tsunami propagation on parallel computers using a hybrid software framework

Simulating tsunami propagation on parallel computers using a hybrid software framework Simulating tsunami propagation on parallel computers using a hybrid software framework Xing Simula Research Laboratory, Norway Department of Informatics, University of Oslo March 12, 2007 Outline Intro

More information

2.7 Cloth Animation. Jacobs University Visualization and Computer Graphics Lab : Advanced Graphics - Chapter 2 123

2.7 Cloth Animation. Jacobs University Visualization and Computer Graphics Lab : Advanced Graphics - Chapter 2 123 2.7 Cloth Animation 320491: Advanced Graphics - Chapter 2 123 Example: Cloth draping Image Michael Kass 320491: Advanced Graphics - Chapter 2 124 Cloth using mass-spring model Network of masses and springs

More information

Computational issues in linear programming

Computational issues in linear programming Computational issues in linear programming Julian Hall School of Mathematics University of Edinburgh 15th May 2007 Computational issues in linear programming Overview Introduction to linear programming

More information

Combinatorial problems in a Parallel Hybrid Linear Solver

Combinatorial problems in a Parallel Hybrid Linear Solver Combinatorial problems in a Parallel Hybrid Linear Solver Ichitaro Yamazaki and Xiaoye Li Lawrence Berkeley National Laboratory François-Henry Rouet and Bora Uçar ENSEEIHT-IRIT and LIP, ENS-Lyon SIAM workshop

More information

Data mining with sparse grids

Data mining with sparse grids Data mining with sparse grids Jochen Garcke and Michael Griebel Institut für Angewandte Mathematik Universität Bonn Data mining with sparse grids p.1/40 Overview What is Data mining? Regularization networks

More information

An Object Oriented Finite Element Library

An Object Oriented Finite Element Library An Object Oriented Finite Element Library Release 3.1.0 Rachid Touzani Laboratoire de Mathématiques Blaise Pascal Université Clermont Auvergne 63177 Aubière, France e-mail: Rachid.Touzani@univ-bpclermont.fr

More information

Data mining with sparse grids using simplicial basis functions

Data mining with sparse grids using simplicial basis functions Data mining with sparse grids using simplicial basis functions Jochen Garcke and Michael Griebel Institut für Angewandte Mathematik Universität Bonn Part of the work was supported within the project 03GRM6BN

More information

The DRM-MD integral equation method for the numerical solution of convection-diffusion

The DRM-MD integral equation method for the numerical solution of convection-diffusion The DRM-MD integral equation method for the numerical solution of convection-diffusion equation V. Popov & H. Power Wessex Institute of Technology, Ashurst Lodge, Ashurst, Abstract This work presents a

More information