Preconditioning for large scale µfe analysis of 3D poroelasticity

Size: px
Start display at page:

Download "Preconditioning for large scale µfe analysis of 3D poroelasticity"

Transcription

1 ECBA, Graz, July 2 5, /38 Preconditioning for large scale µfe analysis of 3D poroelasticity Peter Arbenz, Cyril Flaig, Erhan Turan ETH Zurich Workshop on Efficient Solvers in Biomedical Applications Graz, July 2 5, 2012

2 CBA, Graz, July 2 5, /38 Outline 1 Introduction 2 Mathematical model 3 Numerics 4 Numerical results 5 Poroelasticity 6 Implementation 7 More Results 8 Summary

3 ECBA, Graz, July 2 5, /38 The need for µfe analysis of bones I Osteoporosis A disease characterized by low bone mass and deterioration of bone microarchitecture (trabecular bone). High lifetime risk for a fracture caused by osteoporosis. In Switzerland, the risk for an osteoporotic fracture in women above 50 years is about 50%, for men the risk is about 20%. Since global parameters like bone density do not admit to predict the fracture risk, patients have to be treated in a more individual way.

4 ECBA, Graz, July 2 5, /38 The need for µfe analysis of bones Osteoporosis A disease characterized by low bone mass and deterioration of bone microarchitecture (trabecular bone). High lifetime risk for a fracture caused by osteoporosis. In Switzerland, the risk for an osteoporotic fracture in women above 50 years is about 50%, for men the risk is about 20%. Since global parameters like bone density do not admit to predict the fracture risk, patients have to be treated in a more individual way. Research µfe analysis improves the understanding of the importance of the structure of the trabecular bone.

5 ECBA, Graz, July 2 5, /38 The need for µfe analysis of bones II Progress New approach consists of combining 3D high-resolution CT scans of individual bones with a micro-finite element (µfe) analysis.

6 Another problem A. Wirth et al.: Mechanical competence of bone-implant systems can accurately be determined by image-based µfe analyses. Arch. Appl. Mech. 80 (2010), ECBA, Graz, July 2 5, /38

7 ECBA, Graz, July 2 5, /38 Work flow pqct: Peripheral Quantitative Computed Tomography

8 CBA, Graz, July 2 5, /38 The mathematical model Equations of linearized 3D elasticity (pure displacement formulation): Find displacement field u [H 1 (Ω)] 3 that minimizes total potential energy Ω [ µε(u) : ε(u) + λ 2 (divu)2 f t u ] dω gs t udγ, Γ N Eν with Lamé s constants λ = (1+ν)(1 2ν), µ = E 2(1+ν), volume forces f, boundary tractions g, symmetric strain tensor ε(u) := 1 2 ( u + ( u)t ). The computational domain Ω consist of identical voxels

9 CBA, Graz, July 2 5, /38 The mathematical model Equations of linearized 3D elasticity (pure displacement formulation): Find displacement field u [H 1 (Ω)] 3 that minimizes total potential energy Ω [ µε(u) : ε(u) + λ 2 (divu)2 f t u ] dω gs t udγ, Γ N Eν with Lamé s constants λ = (1+ν)(1 2ν), µ = E 2(1+ν), volume forces f, boundary tractions g, symmetric strain tensor ε(u) := 1 2 ( u + ( u)t ). The computational domain Ω consist of identical voxels

10 ECBA, Graz, July 2 5, /38 Discretization using voxel elements Finite element approximation: displacements u represented by piecewise trilinear polynomials Each voxel has 8 nodes In each node we have 3 degrees of freedom: displacements in x-, y-, z-direction In total 24 degrees of freedom per voxel strains / stresses computable by means of nodal displacements

11 ECBA, Graz, July 2 5, /38 Solving the system of equations The discretization results in a linear system of equation: Au = f A is sparse and symmetric positive definite. The fine resolution of the CT scan entails that A is HUGE. Approach to solve this linear system: preconditioned conjugate gradient (PCG) algorithm Diagonal (Jacobi) preconditioner (Rietbergen et al., 1996) Avoid the assembling of the stiffness matrix. Compute the matrix-vector multiplication in an element-by-element (EBE) fashion n el A = T e A e Te T, (1) e=1 Multigrid preconditioning (Ruge Stüben) (Adams et al., 2004) Multigrid preconditioning (SA-AMG) (Arbenz et al., 2008)

12 ECBA, Graz, July 2 5, /38 ParFE: PCG with SA-AMG preconditioning Mathematics of ParFE Smoothed aggregation AMG (Vaněk et al., 1996): Smoothed prolongator (P i ) formed from the aggregation of the matrix graph and near-nullspace. Coarser level matrix: K i+1 = Pi T K i P i Smoother: Chebyshev polynomial that is small on the upper part of the spectrum of K i Software of ParFE Trilinos ( Framework for generation of parallel objects and solvers (Heroux et al., 2000) Packages used: AztecOO/Belos, ML, Zoltan ( ParMETIS) ParFE (

13 ECBA, Graz, July 2 5, /38 ParFE: PCG with SA-AMG preconditioning Mathematics of ParFE Smoothed aggregation AMG (Vaněk et al., 1996): Smoothed prolongator (P i ) formed from the aggregation of the matrix graph and near-nullspace. Coarser level matrix: K i+1 = Pi T K i P i Smoother: Chebyshev polynomial that is small on the upper part of the spectrum of K i Software of ParFE Trilinos ( Framework for generation of parallel objects and solvers (Heroux et al., 2000) Packages used: AztecOO/Belos, ML, Zoltan ( ParMETIS) ParFE (

14 Introduction Modelling Numerics Results Poroelasticity Implementation More Results Summary Very large real bone ( dofs) Effective strains with zooms. (Image by Jean Favre, CSCS) ECBA, Graz, July 2 5, /38

15 ECBA, Graz, July 2 5, /38 PCG with matrix-free GMG preconditioning Motivation ParFE does not exploit regular structures except on finest level. To reduce overhead for information on unstructured grids: Use regular grids on all levels. Apply geometric multigrid Stay matrix-free on all levels Two approaches: Embed the bone structure in a cuboid with original regular grid extended and fill void very soft material (Margenov, 2006). Use geometric MG (Flaig et al., LNCS, 2011) The same, but only with bone data: pointer-less octree approach (Flaig et al., PARCO, 2011) Software: C++ plus MPI and a few libraries.

16 ECBA, Graz, July 2 5, /38 Some properties of the algorithm Octree structure, linearized on all levels. EBE: standard element matrices multiplied by voxel-wise bone-volume fraction Space-filling curve for numbering of elements/nodes High cache-hit rates in matvecs Used for partitioning of domain for // processing Equally sized sets of contiguous nodes perfect load balance About 15 mio. dofs per compute core with 1.33 GB memory. SA-AMG needs more than 16 more memory space

17 ECBA, Graz, July 2 5, /38 Weak scalability Weak scalability test with two meshes: c240 is encased in a cube with dofs c320 is encased in a cube with dofs Bigger grids are generated by 3D-mirroring Chebyshev smoother deg 6 Stopping criterion: r k M r 0 M 1 Biggest mesh: dofs

18 ECBA, Graz, July 2 5, /38 Weak scalability ( dofs) Smoother: Cheb. deg. 6, tol Time [s] c320 iterations c240 iterations c320 solving time c240 solving time Iterations Number of Cores Timings are measured on a Cray XT5 at CSCS. The iteration counts vary between 15 and 17. Perfect weak scalability up to 8000 cores.

19 ECBA, Graz, July 2 5, /38 Simulation of bone formation remodeling CT scan of bone specimen exposing voxel structure Bone reacts on forces it has to sustain Adapts structure to lower stresses Increases bone strength and stability Simulation of bone remodeling is a time-dependent process Sequence of slightly changing linear systems Consider only the first system Complicated geometry implies FE analysis with many degrees of freedom (dof)

20 Poroelasticity Linear Elasticity (λ + µ) ( u) + µ 2 u α p + F = 0, (2) λ, µ: Lamé constants; α Biot Willis coefficient Darcy s law k permeability, η dynamic viscosity Mass conservation α ε kk t f = k p. (3) η + S ε p t + f = S f. (4) S ε measure of released fluid volume per unit pressure in the control volume, S f is an external source or sink. ECBA, Graz, July 2 5, /38

21 CBA, Graz, July 2 5, /38 Weak formulation Ω [2µε(u):ε(v) + λ div u div v] dω α p div v dω = 0 Ω K 1 f g dω p div g dω = 0 Ω Ω α q div u dω q div f dω S ɛ p qdω = Ω Ω Ω Here, F = 0, u (H 1 (Ω)) 3, f H(div; Ω), p L 2 (Ω) (+bc) Boundary conditions: u(x, t) = u D, on Ω D, σ(x, t) n(x) = t(x, t), on Ω N, f(x, t) n(x) = 0, on Ω. Ω S f q dω

22 ECBA, Graz, July 2 5, /38 Finite element displacement/flux/pressure formulation FE Spaces: Q 1 for u, RT 0 for f, P 0 for p. Nodal, facial and elemental unknowns. The resulting system is symmetric indefinite. Alternative (u/p) formulation has fewer degrees of freedom, but denser matrices. (u/f /p) formulation: Stable. Primary variables are kept in the system: Stokes flow. Constant flux across boundaries: continuity.

23 ECBA, Graz, July 2 5, /38 Displacement/flux/pressure formulation Ω [2µε(u):ε(v) + λ div u div v] dω α p div vdω = 0 Ω K 1 f gdω p div gdω = 0 Ω Ω α q div udω q div fdω S ɛ p qdω = Ω Ω Ω Ω S f qdω A uu 0 A T pu u 0 0 A ff A T pf f = 0 A pu A pf A pp p b }{{} A

24 Introduction Modelling Numerics Results Poroelasticity Implementation More Results Summary Displacement/flux/pressure sparsity of A ECBA, Graz, July 2 5, nz = /38

25 ECBA, Graz, July 2 5, /38 General approach Use (flexible) GMRES, MINRES as solver for indefinite symmetric linear systems. Preconditioner with same block structure. Time dependency: first order implicit Euler (FD) Software: Exploit Trilinos framework, packages: Belos, ML, Amesos

26 ECBA, Graz, July 2 5, /38 Distribution of 3-component vector x u f p

27 ECBA, Graz, July 2 5, /38 Block-diagonal preconditioner Block diagonal preconditioner A uu 0 0 M 1 = 0 A ff S where M 1 not feasible. S = A pp A pu A 1 uu A T pu A pf A 1 ff AT pf Approximate S by Ŝ = A pp A pf diag (A ff ) 1 A T pf S and Ŝ are spectrally equivalent (Lipnikov, 2002) Ŝ can be generated as finite difference approximation of c 1 p + c 2 p of the pressure variables (at voxel centers).

28 ECBA, Graz, July 2 5, /38 Block-diagonal preconditioner (con t) Replace A uu by AMG V-cycle (as implemented in Trilinos ML) Replace A uu by its diagonal diag(a ff ) Replace Ŝ by AMG V-cycle A uu diag(a ff ) Ŝ A uu A ff Ŝ

29 ECBA, Graz, July 2 5, /38 Block upper-triangular preconditioner Also incorporate upper off-diagonal blocks: A uu 0 A T pu M 2 = 0 A ff A T pf 0 0 S GMRES with this preconditioner converges in 2 iteration steps. A M 1 2 = I I A pu A 1 uu A pf A 1 ff I

30 ECBA, Graz, July 2 5, /38 Block upper-triangular preconditioner Also incorporate upper off-diagonal blocks: A uu 0 A T pu M 2 = 0 A ff A T pf 0 0 S GMRES with this preconditioner converges in 2 iteration steps. M 2 not feasible. Solve diagonal block systems with preconditioners as in block-diagonal preconditioner: A uu : (PCG with) AMG preconditioner ML A ff : direct solve (no fill-in) Ŝ S: (PCG with) AMG preconditioner ML Accuracy for inner solves?

31 ECBA, Graz, July 2 5, /38 Test problem I: Benchmark problem Terzaghi s 1D Consolidation (Transient analytical) Modeled with 3D geometries using proper boundary conditions up to time steps FGMRES Solution shows stable temporal behavior. Only first few iteration steps are hard to solve Later iteration steps are much easier to solve due to good initial guess

32 Introduction Modelling Numerics Results Poroelasticity Implementation More Results Summary Test problem II: full domain mesh id b1 1 b1 2 b1 4 b1 8 b1 16 b1 32 b1 64 b1 128 ECBA, Graz, July 2 5, 2012 elements nodes faces total dof /38

33 ECBA, Graz, July 2 5, /38 Number of iterations Solve Ax = y, outer tolerance 10 5 Preconditioner A: Block diagonal, V-cycle for A uu and Ŝ Preconditioner B: Block upper-triangular, AMG-preconditioned PCG, inner tolerance 10 8 for A uu, 10 5 for Ŝ, outer iterations Prec. A Prec. B b_1 b_2 b_4 b_8 b_16 b_32 b_64 b_128 model id

34 Strong scalability b_32 A b_32 B b_64 A b_64 B linear 10 2 belos time (s) number of cores GMRES is faster with block-diagonal preconditioner than with block-triangular, although iteration count of the latter is smaller. The latter is too time-consuming. ECBA, Graz, July 2 5, /38

35 ECBA, Graz, July 2 5, /38 More preconditioners diagonal-i: block-diagonal as before. diagonal-ii: block-diagonal with PCG(10 5 ). triangular-i: block-triangular as before (PCG(10 8 )). triangular-ii: block-triangular with PCG(10 5 ). triangular-iii: block-triangular with V-cycle.

36 ECBA, Graz, July 2 5, /38 More preconditioners Comparison # cores diag-i diag-ii triang-i triang-ii triang-iii Table 2: Comparison of the preconditioners on b1 64 run time (sec.) # cores diag-i diag-ii triang-i triang-ii triang-iii Table 3: Comparison of the preconditioners on b1 64 iterations

37 Introduction Modelling Numerics Results Poroelasticity Implementation More Results Summary Test problem III: bone geometries ECBA, Graz, July 2 5, /38

38 ECBA, Graz, July 2 5, /38 Test Models mesh id elements nodes faces total dof c c c Table 4: Test meshes on a bone sample

39 ECBA, Graz, July 2 5, /38 Bone geometries Comparison preconditioner c 040 c 080 c 160 diagonal-i triangular-i triangular-ii triangular-iii Table 5: Number of outer iterations preconditioner c 040 c 080 c 160 diagonal-i triangular-i triangular-ii triangular-iii Table 6: Belos time

40 ECBA, Graz, July 2 5, /38 Summary Plain elasticity solver ParFE extendend to include poroelastic effects. Trilinos/Belos (FGMRES) is the main solver. Mixed finite element formulation is implemented into our elasticity solver ParFE PorFE. More investigations/improvements regarding preconditioners. Node-face-element-aware partitioning to be improved ParMetis.

A highly scalable matrix-free multigrid solver for µfe analysis of bone structures based on a pointer-less octree

A highly scalable matrix-free multigrid solver for µfe analysis of bone structures based on a pointer-less octree Talk at SuperCA++, Bansko BG, Apr 23, 2012 1/28 A highly scalable matrix-free multigrid solver for µfe analysis of bone structures based on a pointer-less octree P. Arbenz, C. Flaig ETH Zurich Talk at

More information

Extreme Scalability Challenges in Micro-Finite Element Simulations of Human Bone

Extreme Scalability Challenges in Micro-Finite Element Simulations of Human Bone Extreme Scalability Challenges in Micro-Finite Element Simulations of Human Bone C. Bekas, A. Curioni IBM Research, Zurich Research Laboratory, Switzerland P. Arbenz, C. Flaig, Computer Science Dept.,

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

Research Collection. WebParFE A web interface for the high performance parallel finite element solver ParFE. Report. ETH Library

Research Collection. WebParFE A web interface for the high performance parallel finite element solver ParFE. Report. ETH Library Research Collection Report WebParFE A web interface for the high performance parallel finite element solver ParFE Author(s): Paranjape, Sumit; Kaufmann, Martin; Arbenz, Peter Publication Date: 2009 Permanent

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

SELECTIVE ALGEBRAIC MULTIGRID IN FOAM-EXTEND

SELECTIVE ALGEBRAIC MULTIGRID IN FOAM-EXTEND Student Submission for the 5 th OpenFOAM User Conference 2017, Wiesbaden - Germany: SELECTIVE ALGEBRAIC MULTIGRID IN FOAM-EXTEND TESSA UROIĆ Faculty of Mechanical Engineering and Naval Architecture, Ivana

More information

An algebraic multi-grid implementation in FEniCS for solving 3d fracture problems using XFEM

An algebraic multi-grid implementation in FEniCS for solving 3d fracture problems using XFEM An algebraic multi-grid implementation in FEniCS for solving 3d fracture problems using XFEM Axel Gerstenberger, Garth N. Wells, Chris Richardson, David Bernstein, and Ray Tuminaro FEniCS 14, Paris, France

More information

Computational Fluid Dynamics - Incompressible Flows

Computational Fluid Dynamics - Incompressible Flows Computational Fluid Dynamics - Incompressible Flows March 25, 2008 Incompressible Flows Basis Functions Discrete Equations CFD - Incompressible Flows CFD is a Huge field Numerical Techniques for solving

More information

Lecture 23: Bits and Bones

Lecture 23: Bits and Bones Lecture 23: Bits and Bones David Bindel 19 Apr 2010 Logistics Projects! Things to remember: Stage your work to get something by end-of-semester Important thing is reasoning about performance Do come talk

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

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

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

Research Collection. Bone Structure Analysis with GPGPUs. Master Thesis. ETH Library. Author(s): Kellenberger, Daniel. Publication Date: 2013

Research Collection. Bone Structure Analysis with GPGPUs. Master Thesis. ETH Library. Author(s): Kellenberger, Daniel. Publication Date: 2013 Research Collection Master Thesis Bone Structure Analysis with GPGPUs Author(s): Kellenberger, Daniel Publication Date: 2013 Permanent Link: https://doi.org/10.3929/ethz-a-009908618 Rights / License: In

More information

Workshop on Efficient Solvers in Biomedical Applications, Graz, July 2-5, 2012

Workshop on Efficient Solvers in Biomedical Applications, Graz, July 2-5, 2012 Workshop on Efficient Solvers in Biomedical Applications, Graz, July 2-5, 2012 This work was performed under the auspices of the U.S. Department of Energy by under contract DE-AC52-07NA27344. Lawrence

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

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

Contents. F10: Parallel Sparse Matrix Computations. Parallel algorithms for sparse systems Ax = b. Discretized domain a metal sheet

Contents. F10: Parallel Sparse Matrix Computations. Parallel algorithms for sparse systems Ax = b. Discretized domain a metal sheet Contents 2 F10: Parallel Sparse Matrix Computations Figures mainly from Kumar et. al. Introduction to Parallel Computing, 1st ed Chap. 11 Bo Kågström et al (RG, EE, MR) 2011-05-10 Sparse matrices and storage

More information

Predicting Tumour Location by Modelling the Deformation of the Breast using Nonlinear Elasticity

Predicting Tumour Location by Modelling the Deformation of the Breast using Nonlinear Elasticity Predicting Tumour Location by Modelling the Deformation of the Breast using Nonlinear Elasticity November 8th, 2006 Outline Motivation Motivation Motivation for Modelling Breast Deformation Mesh Generation

More information

Control Volume Finite Difference On Adaptive Meshes

Control Volume Finite Difference On Adaptive Meshes Control Volume Finite Difference On Adaptive Meshes Sanjay Kumar Khattri, Gunnar E. Fladmark, Helge K. Dahle Department of Mathematics, University Bergen, Norway. sanjay@mi.uib.no Summary. In this work

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

Design of Finite Element Software for Modeling Bone Deformation and Failure

Design of Finite Element Software for Modeling Bone Deformation and Failure Design of Finite Element Software for Modeling Bone Deformation and Failure D. Bindel Department of Computer Science Cornell University 22 Apr 2010 Goal state What I hope to get across today: Show some

More information

Janne Martikainen 1. Introduction

Janne Martikainen 1. Introduction Mathematical Modelling and Numerical Analysis ESAIM: M2AN Modélisation Mathématique et Analyse Numérique M2AN, Vol. 37, N o 1, 2003, pp. 133 142 DOI: 10.1051/m2an:2003016 NUMERICAL STUDY OF TWO SPARSE

More information

A Hybrid Geometric+Algebraic Multigrid Method with Semi-Iterative Smoothers

A Hybrid Geometric+Algebraic Multigrid Method with Semi-Iterative Smoothers NUMERICAL LINEAR ALGEBRA WITH APPLICATIONS Numer. Linear Algebra Appl. 013; 00:1 18 Published online in Wiley InterScience www.interscience.wiley.com). A Hybrid Geometric+Algebraic Multigrid Method with

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

A Study of Prolongation Operators Between Non-nested Meshes

A Study of Prolongation Operators Between Non-nested Meshes A Study of Prolongation Operators Between Non-nested Meshes Thomas Dickopf 1 and Rolf Krause 2 1 Institute for Numerical Simulation, University of Bonn, 53115 Bonn, Germany, dickopf@ins.uni-bonn.de 2 Institute

More information

Higher Order Multigrid Algorithms for a 2D and 3D RANS-kω DG-Solver

Higher Order Multigrid Algorithms for a 2D and 3D RANS-kω DG-Solver www.dlr.de Folie 1 > HONOM 2013 > Marcel Wallraff, Tobias Leicht 21. 03. 2013 Higher Order Multigrid Algorithms for a 2D and 3D RANS-kω DG-Solver Marcel Wallraff, Tobias Leicht DLR Braunschweig (AS - C

More information

S0432 NEW IDEAS FOR MASSIVELY PARALLEL PRECONDITIONERS

S0432 NEW IDEAS FOR MASSIVELY PARALLEL PRECONDITIONERS S0432 NEW IDEAS FOR MASSIVELY PARALLEL PRECONDITIONERS John R Appleyard Jeremy D Appleyard Polyhedron Software with acknowledgements to Mark A Wakefield Garf Bowen Schlumberger Outline of Talk Reservoir

More information

Scalable Preconditioners for Navier Stokes Equations in Hemodynamic Simulations

Scalable Preconditioners for Navier Stokes Equations in Hemodynamic Simulations 1/34 Scalable Preconditioners for Navier Stokes Equations in Hemodynamic Simulations Simone Deparis, Gwenol Grandperrin, Alfio Quarteroni MATHICSE - Chair of Modelling and Scientific Computing (CMCS) EPFL,

More information

ACCELERATING CFD AND RESERVOIR SIMULATIONS WITH ALGEBRAIC MULTI GRID Chris Gottbrath, Nov 2016

ACCELERATING CFD AND RESERVOIR SIMULATIONS WITH ALGEBRAIC MULTI GRID Chris Gottbrath, Nov 2016 ACCELERATING CFD AND RESERVOIR SIMULATIONS WITH ALGEBRAIC MULTI GRID Chris Gottbrath, Nov 2016 Challenges What is Algebraic Multi-Grid (AMG)? AGENDA Why use AMG? When to use AMG? NVIDIA AmgX Results 2

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

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

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

Multigrid Methods for Markov Chains

Multigrid Methods for Markov Chains Multigrid Methods for Markov Chains Hans De Sterck Department of Applied Mathematics, University of Waterloo collaborators Killian Miller Department of Applied Mathematics, University of Waterloo, Canada

More information

Case 3.1: Turbulent Flow over a 2D Multi-Element Airfoil. Summary of Results. Marco Ceze

Case 3.1: Turbulent Flow over a 2D Multi-Element Airfoil. Summary of Results. Marco Ceze Case 3.1: Turbulent Flow over a 2D Multi-Element Airfoil Summary of Results Marco Ceze (mceze@umich.edu) 2 nd International Workshop on High-Order CFD Methods, May 27-28, Cologne, Germany C3.1 1/14 Case

More information

Parallel Computations

Parallel Computations Parallel Computations Timo Heister, Clemson University heister@clemson.edu 2015-08-05 deal.ii workshop 2015 2 Introduction Parallel computations with deal.ii: Introduction Applications Parallel, adaptive,

More information

Why Use the GPU? How to Exploit? New Hardware Features. Sparse Matrix Solvers on the GPU: Conjugate Gradients and Multigrid. Semiconductor trends

Why Use the GPU? How to Exploit? New Hardware Features. Sparse Matrix Solvers on the GPU: Conjugate Gradients and Multigrid. Semiconductor trends Imagine stream processor; Bill Dally, Stanford Connection Machine CM; Thinking Machines Sparse Matrix Solvers on the GPU: Conjugate Gradients and Multigrid Jeffrey Bolz Eitan Grinspun Caltech Ian Farmer

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

A node-based agglomeration AMG solver for linear elasticity in thin bodies

A node-based agglomeration AMG solver for linear elasticity in thin bodies COMMUNICATIONS IN NUMERICAL METHODS IN ENGINEERING Commun. Numer. Meth. Engng 2000; 00:1 6 [Version: 2002/09/18 v1.02] A node-based agglomeration AMG solver for linear elasticity in thin bodies Prasad

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

Revised Sheet Metal Simulation, J.E. Akin, Rice University

Revised Sheet Metal Simulation, J.E. Akin, Rice University Revised Sheet Metal Simulation, J.E. Akin, Rice University A SolidWorks simulation tutorial is just intended to illustrate where to find various icons that you would need in a real engineering analysis.

More information

Resilient geometric finite-element multigrid algorithms using minimised checkpointing

Resilient geometric finite-element multigrid algorithms using minimised checkpointing Resilient geometric finite-element multigrid algorithms using minimised checkpointing Dominik Göddeke, Mirco Altenbernd, Dirk Ribbrock Institut für Angewandte Mathematik (LS3) Fakultät für Mathematik TU

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

Introduction to Multigrid and its Parallelization

Introduction to Multigrid and its Parallelization Introduction to Multigrid and its Parallelization! Thomas D. Economon Lecture 14a May 28, 2014 Announcements 2 HW 1 & 2 have been returned. Any questions? Final projects are due June 11, 5 pm. If you are

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

Iterative Sparse Triangular Solves for Preconditioning

Iterative Sparse Triangular Solves for Preconditioning Euro-Par 2015, Vienna Aug 24-28, 2015 Iterative Sparse Triangular Solves for Preconditioning Hartwig Anzt, Edmond Chow and Jack Dongarra Incomplete Factorization Preconditioning Incomplete LU factorizations

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

Block Distributed Schur Complement Preconditioners for CFD Computations on Many-Core Systems

Block Distributed Schur Complement Preconditioners for CFD Computations on Many-Core Systems Block Distributed Schur Complement Preconditioners for CFD Computations on Many-Core Systems Dr.-Ing. Achim Basermann, Melven Zöllner** German Aerospace Center (DLR) Simulation- and Software Technology

More information

Adaptive-Mesh-Refinement Pattern

Adaptive-Mesh-Refinement Pattern Adaptive-Mesh-Refinement Pattern I. Problem Data-parallelism is exposed on a geometric mesh structure (either irregular or regular), where each point iteratively communicates with nearby neighboring points

More information

A Comparison of Algebraic Multigrid Preconditioners using Graphics Processing Units and Multi-Core Central Processing Units

A Comparison of Algebraic Multigrid Preconditioners using Graphics Processing Units and Multi-Core Central Processing Units A Comparison of Algebraic Multigrid Preconditioners using Graphics Processing Units and Multi-Core Central Processing Units Markus Wagner, Karl Rupp,2, Josef Weinbub Institute for Microelectronics, TU

More information

Multigrid. James Demmel. Poisson s equation in 1D: T = Graph and stencil. 2 u/ x 2 = f(x)

Multigrid. James Demmel. Poisson s equation in 1D: T =   Graph and stencil. 2 u/ x 2 = f(x) Multigrid James Demmel www.cs.berkeley.edu/~demmel/ma221_spr16 Poisson s equation in 1D: 2 u/ x 2 = f(x) T = 2-1 -1 2-1 -1 2-1 -1 2-1 -1 2 Graph and stencil -1 2-1 1 2D Poisson s equation Similar to the

More information

Stokes Preconditioning on a GPU

Stokes Preconditioning on a GPU Stokes Preconditioning on a GPU Matthew Knepley 1,2, Dave A. Yuen, and Dave A. May 1 Computation Institute University of Chicago 2 Department of Molecular Biology and Physiology Rush University Medical

More information

AmgX 2.0: Scaling toward CORAL Joe Eaton, November 19, 2015

AmgX 2.0: Scaling toward CORAL Joe Eaton, November 19, 2015 AmgX 2.0: Scaling toward CORAL Joe Eaton, November 19, 2015 Agenda Introduction to AmgX Current Capabilities Scaling V2.0 Roadmap for the future 2 AmgX Fast, scalable linear solvers, emphasis on iterative

More information

Finite Volume Methodology for Contact Problems of Linear Elastic Solids

Finite Volume Methodology for Contact Problems of Linear Elastic Solids Finite Volume Methodology for Contact Problems of Linear Elastic Solids H. Jasak Computational Dynamics Ltd. Hythe House 200 Shepherds Bush Road London W6 7NY, England E-mail: h.jasak@cd.co.uk H.G. Weller

More information

Model Reduction for High Dimensional Micro-FE Models

Model Reduction for High Dimensional Micro-FE Models Model Reduction for High Dimensional Micro-FE Models Rudnyi E. B., Korvink J. G. University of Freiburg, IMTEK-Department of Microsystems Engineering, {rudnyi,korvink}@imtek.uni-freiburg.de van Rietbergen

More information

Smoothers. < interactive example > Partial Differential Equations Numerical Methods for PDEs Sparse Linear Systems

Smoothers. < interactive example > Partial Differential Equations Numerical Methods for PDEs Sparse Linear Systems Smoothers Partial Differential Equations Disappointing convergence rates observed for stationary iterative methods are asymptotic Much better progress may be made initially before eventually settling into

More information

Dendro: Parallel algorithms for multigrid and AMR methods on 2:1 balanced octrees

Dendro: Parallel algorithms for multigrid and AMR methods on 2:1 balanced octrees Dendro: Parallel algorithms for multigrid and AMR methods on 2:1 balanced octrees Rahul S. Sampath, Santi S. Adavani, Hari Sundar, Ilya Lashuk, and George Biros University of Pennsylvania Abstract In this

More information

How to use sparse lib in FEM package

How to use sparse lib in FEM package How to use sparse lib in FEM package October 18, 2005 Contents 1 Introduction 1 2 Three Basic Components in sparse lib 1 3 Parameters or Basic Information for sparse lib Library 2 3.1 Input Parameters.........................

More information

Efficient Multigrid based solvers for Isogeometric Analysis

Efficient Multigrid based solvers for Isogeometric Analysis Efficient Multigrid based solvers for Isogeometric Analysis R. Tielen, M. Möller and C. Vuik Delft Institute of Applied Mathematics (DIAM) Numerical Analysis / 22 Isogeometric Analysis (IgA) Extension

More information

A node-based agglomeration AMG solver for linear elasticity in thin bodies

A node-based agglomeration AMG solver for linear elasticity in thin bodies COMMUNICATIONS IN NUMERICAL METHODS IN ENGINEERING Commun. Numer. Meth. Engng 2009; 25:219 236 Published online 3 April 2008 in Wiley InterScience (www.interscience.wiley.com)..1116 A node-based agglomeration

More information

cuibm A GPU Accelerated Immersed Boundary Method

cuibm A GPU Accelerated Immersed Boundary Method cuibm A GPU Accelerated Immersed Boundary Method S. K. Layton, A. Krishnan and L. A. Barba Corresponding author: labarba@bu.edu Department of Mechanical Engineering, Boston University, Boston, MA, 225,

More information

High-Order Navier-Stokes Simulations using a Sparse Line-Based Discontinuous Galerkin Method

High-Order Navier-Stokes Simulations using a Sparse Line-Based Discontinuous Galerkin Method High-Order Navier-Stokes Simulations using a Sparse Line-Based Discontinuous Galerkin Method Per-Olof Persson University of California, Berkeley, Berkeley, CA 9472-384, U.S.A. We study some of the properties

More information

Automatic Generation of Algorithms and Data Structures for Geometric Multigrid. Harald Köstler, Sebastian Kuckuk Siam Parallel Processing 02/21/2014

Automatic Generation of Algorithms and Data Structures for Geometric Multigrid. Harald Köstler, Sebastian Kuckuk Siam Parallel Processing 02/21/2014 Automatic Generation of Algorithms and Data Structures for Geometric Multigrid Harald Köstler, Sebastian Kuckuk Siam Parallel Processing 02/21/2014 Introduction Multigrid Goal: Solve a partial differential

More information

Finite Element Multigrid Solvers for PDE Problems on GPUs and GPU Clusters

Finite Element Multigrid Solvers for PDE Problems on GPUs and GPU Clusters Finite Element Multigrid Solvers for PDE Problems on GPUs and GPU Clusters Robert Strzodka Integrative Scientific Computing Max Planck Institut Informatik www.mpi-inf.mpg.de/ ~strzodka Dominik Göddeke

More information

Efficient Use of Iterative Solvers in Nested Topology Optimization

Efficient Use of Iterative Solvers in Nested Topology Optimization Efficient Use of Iterative Solvers in Nested Topology Optimization Oded Amir, Mathias Stolpe and Ole Sigmund Technical University of Denmark Department of Mathematics Department of Mechanical Engineering

More information

CSMA A scalable implementation of a volume coupling scheme for the modeling of polycrystalline materials. 1 Motivation

CSMA A scalable implementation of a volume coupling scheme for the modeling of polycrystalline materials. 1 Motivation A scalable implementation of a volume coupling scheme for the modeling of polycrystalline materials T. Milanetto Schlittler, R. Cottereau 2 CSMA 207 3ème Colloque National en Calcul des Structures 5-9

More information

Finite Volume Discretization on Irregular Voronoi Grids

Finite Volume Discretization on Irregular Voronoi Grids Finite Volume Discretization on Irregular Voronoi Grids C.Huettig 1, W. Moore 1 1 Hampton University / National Institute of Aerospace Folie 1 The earth and its terrestrial neighbors NASA Colin Rose, Dorling

More information

Matrix-free multi-gpu Implementation of Elliptic Solvers for strongly anisotropic PDEs

Matrix-free multi-gpu Implementation of Elliptic Solvers for strongly anisotropic PDEs Iterative Solvers Numerical Results Conclusion and outlook 1/18 Matrix-free multi-gpu Implementation of Elliptic Solvers for strongly anisotropic PDEs Eike Hermann Müller, Robert Scheichl, Eero Vainikko

More information

Finite Element Implementation

Finite Element Implementation Chapter 8 Finite Element Implementation 8.1 Elements Elements andconditions are the main extension points of Kratos. New formulations can be introduced into Kratos by implementing a new Element and its

More information

f xx + f yy = F (x, y)

f xx + f yy = F (x, y) Application of the 2D finite element method to Laplace (Poisson) equation; f xx + f yy = F (x, y) M. R. Hadizadeh Computer Club, Department of Physics and Astronomy, Ohio University 4 Nov. 2013 Domain

More information

Level Set Methods and Fast Marching Methods

Level Set Methods and Fast Marching Methods Level Set Methods and Fast Marching Methods I.Lyulina Scientific Computing Group May, 2002 Overview Existing Techniques for Tracking Interfaces Basic Ideas of Level Set Method and Fast Marching Method

More information

Implicit schemes for wave models

Implicit schemes for wave models Implicit schemes for wave models Mathieu Dutour Sikirić Rudjer Bo sković Institute, Croatia and Universität Rostock April 17, 2013 I. Wave models Stochastic wave modelling Oceanic models are using grids

More information

Efficient multigrid solvers for strongly anisotropic PDEs in atmospheric modelling

Efficient multigrid solvers for strongly anisotropic PDEs in atmospheric modelling Iterative Solvers Numerical Results Conclusion and outlook 1/22 Efficient multigrid solvers for strongly anisotropic PDEs in atmospheric modelling Part II: GPU Implementation and Scaling on Titan Eike

More information

Multigrid James Demmel

Multigrid James Demmel Multigrid James Demmel www.cs.berkeley.edu/~demmel/ma221 Review of Previous Lectures and Outline Review Poisson equation Overview of Methods for Poisson Equation Jacobi s method Gauss-Seidel method Red-Black

More information

A PARALLEL GEOMETRIC MULTIGRID METHOD FOR FINITE ELEMENTS ON OCTREE MESHES

A PARALLEL GEOMETRIC MULTIGRID METHOD FOR FINITE ELEMENTS ON OCTREE MESHES SIAM J. SCI. COMPUT. Vol. 32, No. 3, pp. 1361 1392 c 2010 Society for Industrial and Applied Mathematics A PARALLEL GEOMETRIC MULTIGRID METHOD FOR FINITE ELEMENTS ON OCTREE MESHES RAHUL S. SAMPATH AND

More information

PhD Student. Associate Professor, Co-Director, Center for Computational Earth and Environmental Science. Abdulrahman Manea.

PhD Student. Associate Professor, Co-Director, Center for Computational Earth and Environmental Science. Abdulrahman Manea. Abdulrahman Manea PhD Student Hamdi Tchelepi Associate Professor, Co-Director, Center for Computational Earth and Environmental Science Energy Resources Engineering Department School of Earth Sciences

More information

Subdivision-stabilised immersed b-spline finite elements for moving boundary flows

Subdivision-stabilised immersed b-spline finite elements for moving boundary flows Subdivision-stabilised immersed b-spline finite elements for moving boundary flows T. Rüberg, F. Cirak Department of Engineering, University of Cambridge, Trumpington Street, Cambridge CB2 1PZ, U.K. Abstract

More information

ADAPTIVE SMOOTHED AGGREGATION (αsa)

ADAPTIVE SMOOTHED AGGREGATION (αsa) ADAPTIVE SMOOTHED AGGREGATION (αsa) M. BREZINA, R. FALGOUT, S. MACLACHLAN, T. MANTEUFFEL, S. MCCORMICK, AND J. RUGE Abstract. Substantial effort has been focused over the last two decades on developing

More information

REDUCING COMPLEXITY IN PARALLEL ALGEBRAIC MULTIGRID PRECONDITIONERS

REDUCING COMPLEXITY IN PARALLEL ALGEBRAIC MULTIGRID PRECONDITIONERS SUBMITTED TO SIAM JOURNAL ON MATRIX ANALYSIS AND APPLICATIONS, SEPTEMBER 2004 REDUCING COMPLEXITY IN PARALLEL ALGEBRAIC MULTIGRID PRECONDITIONERS HANS DE STERCK, ULRIKE MEIER YANG, AND JEFFREY J. HEYS

More information

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Lecture - 36

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Lecture - 36 Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras Lecture - 36 In last class, we have derived element equations for two d elasticity problems

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

Development of an Integrated Computational Simulation Method for Fluid Driven Structure Movement and Acoustics

Development of an Integrated Computational Simulation Method for Fluid Driven Structure Movement and Acoustics Development of an Integrated Computational Simulation Method for Fluid Driven Structure Movement and Acoustics I. Pantle Fachgebiet Strömungsmaschinen Karlsruher Institut für Technologie KIT Motivation

More information

Multigrid Pattern. I. Problem. II. Driving Forces. III. Solution

Multigrid Pattern. I. Problem. II. Driving Forces. III. Solution Multigrid Pattern I. Problem Problem domain is decomposed into a set of geometric grids, where each element participates in a local computation followed by data exchanges with adjacent neighbors. The grids

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

Hierarchical Hybrid Grids

Hierarchical Hybrid Grids Hierarchical Hybrid Grids IDK Summer School 2012 Björn Gmeiner, Ulrich Rüde July, 2012 Contents Mantle convection Hierarchical Hybrid Grids Smoothers Geometric approximation Performance modeling 2 Mantle

More information

Accelerating Double Precision FEM Simulations with GPUs

Accelerating Double Precision FEM Simulations with GPUs Accelerating Double Precision FEM Simulations with GPUs Dominik Göddeke 1 3 Robert Strzodka 2 Stefan Turek 1 dominik.goeddeke@math.uni-dortmund.de 1 Mathematics III: Applied Mathematics and Numerics, University

More information

Introduction to Computer Graphics. Animation (2) May 26, 2016 Kenshi Takayama

Introduction to Computer Graphics. Animation (2) May 26, 2016 Kenshi Takayama Introduction to Computer Graphics Animation (2) May 26, 2016 Kenshi Takayama Physically-based deformations 2 Simple example: single mass & spring in 1D Mass m, position x, spring coefficient k, rest length

More information

The Immersed Interface Method

The Immersed Interface Method The Immersed Interface Method Numerical Solutions of PDEs Involving Interfaces and Irregular Domains Zhiiin Li Kazufumi Ito North Carolina State University Raleigh, North Carolina Society for Industrial

More information

Guidelines for proper use of Plate elements

Guidelines for proper use of Plate elements Guidelines for proper use of Plate elements In structural analysis using finite element method, the analysis model is created by dividing the entire structure into finite elements. This procedure is known

More information

Smoothed Aggregation Multigrid for Cloth Simulation

Smoothed Aggregation Multigrid for Cloth Simulation Smoothed Aggregation Multigrid for Cloth Simulation Rasmus Tamstorf Walt Disney Animation Studios Toby Jones Walt Disney Animation Studios Stephen F. McCormick University of Colorado, Boulder Abstract

More information

A High-Order Accurate Unstructured GMRES Solver for Poisson s Equation

A High-Order Accurate Unstructured GMRES Solver for Poisson s Equation A High-Order Accurate Unstructured GMRES Solver for Poisson s Equation Amir Nejat * and Carl Ollivier-Gooch Department of Mechanical Engineering, The University of British Columbia, BC V6T 1Z4, Canada

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

Multilevel Methods for Forward and Inverse Ice Sheet Modeling

Multilevel Methods for Forward and Inverse Ice Sheet Modeling Multilevel Methods for Forward and Inverse Ice Sheet Modeling Tobin Isaac Institute for Computational Engineering & Sciences The University of Texas at Austin SIAM CSE 2015 Salt Lake City, Utah τ 2 T.

More information

Eulerian Techniques for Fluid-Structure Interactions - Part II: Applications

Eulerian Techniques for Fluid-Structure Interactions - Part II: Applications Published in Lecture Notes in Computational Science and Engineering Vol. 103, Proceedings of ENUMATH 2013, pp. 755-762, Springer, 2014 Eulerian Techniques for Fluid-Structure Interactions - Part II: Applications

More information

High Order Nédélec Elements with local complete sequence properties

High Order Nédélec Elements with local complete sequence properties High Order Nédélec Elements with local complete sequence properties Joachim Schöberl and Sabine Zaglmayr Institute for Computational Mathematics, Johannes Kepler University Linz, Austria E-mail: {js,sz}@jku.at

More information

OpenFOAM + GPGPU. İbrahim Özküçük

OpenFOAM + GPGPU. İbrahim Özküçük OpenFOAM + GPGPU İbrahim Özküçük Outline GPGPU vs CPU GPGPU plugins for OpenFOAM Overview of Discretization CUDA for FOAM Link (cufflink) Cusp & Thrust Libraries How Cufflink Works Performance data of

More information

Modeling Strategies for Dynamic Finite Element Cask Analyses

Modeling Strategies for Dynamic Finite Element Cask Analyses Session A Package Analysis: Structural Analysis - Modeling Modeling Strategies for Dynamic Finite Element Cask Analyses Uwe Zencker, Günter Wieser, Linan Qiao, Christian Protz BAM Federal Institute for

More information

A spectral boundary element method

A spectral boundary element method Boundary Elements XXVII 165 A spectral boundary element method A. Calaon, R. Adey & J. Baynham Wessex Institute of Technology, Southampton, UK Abstract The Boundary Element Method (BEM) is not local and

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

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis. Volume, 2, pp. 92. Copyright 2,. ISSN 68-963. ETNA BEHAVIOR OF PLANE RELAXATION METHODS AS MULTIGRID SMOOTHERS IGNACIO M. LLORENTE AND N. DUANE MELSON Abstract.

More information

PATCH TEST OF HEXAHEDRAL ELEMENT

PATCH TEST OF HEXAHEDRAL ELEMENT Annual Report of ADVENTURE Project ADV-99- (999) PATCH TEST OF HEXAHEDRAL ELEMENT Yoshikazu ISHIHARA * and Hirohisa NOGUCHI * * Mitsubishi Research Institute, Inc. e-mail: y-ishi@mri.co.jp * Department

More information