Generic finite element capabilities for forest-of-octrees AMR

Size: px
Start display at page:

Download "Generic finite element capabilities for forest-of-octrees AMR"

Transcription

1 Generic finite element capabilities for forest-of-octrees AMR Carsten Burstedde joint work with Omar Ghattas, Tobin Isaac Institut für Numerische Simulation (INS) Rheinische Friedrich-Wilhelms-Universität Bonn, Germany Institute for Computational Engineering and Sciences (ICES) The University of Texas at Austin, USA Feb 16, 2012 SIAM Conference on Parallel Processing for Scientific Computing Savannah, GA USA

2 What is AMR? Adapt local element size To capture localized features To adjust local resolution/accuracy Whenever required during a simulation

3 What is AMR? Adapt local element size To capture localized features To adjust local resolution/accuracy Whenever required during a simulation!! Distinction: mesh generation (upfront) vs. AMR (dynamic) (Disclaimer: Sometimes terms are used interchangably)

4 What is AMR? local refinement local coarsening dynamic w. G. Stadler, L.C. Wilcox

5 What is AMR? local refinement local coarsening dynamic w. G. Stadler, L.C. Wilcox

6 What is AMR? local refinement local coarsening dynamic w. G. Stadler, L.C. Wilcox

7 Why use AMR? Promised savings Uninteresting regions can be ignored Overall less elements for same accuracy which means less memory and less runtime

8 Why use AMR? Promised savings Uninteresting regions can be ignored Overall less elements for same accuracy which means less memory and less runtime Promised gain Overall higher accuracy with same number of elements which means that models can have more detail Multiscale physics can be resolved

9 Why use AMR? Mantle convection: High resolution for faults and plate boundaries Artist rendering Image by US Geological Survey Simul. (w. M. Gurnis, L. Alisic, CalTech) Surface viscosity (colors), velocity (arrows)

10 Why use AMR? Mantle convection: High resolution for faults and plate boundaries Zoom into the boundary between the Australia/New Hebrides plates (Sim: G. Stadler)

11 Why use AMR? Mantle convection: High resolution for faults and plate boundaries Zoom into the boundary between the Australia/New Hebrides plates (Sim: G. Stadler)

12 How to realize AMR? What is so different from standard finite elements?? Parallel computations rely on load balance Dynamic AMR requires frequent repartitioning Repartitioning is considered a hard problem Yet solving this problem is indispensable

13 Conforming tetrahedral (unstructured) AMR How to realize AMR? mesh data courtesy D. Lazzara, MIT (Re-)partitioning delegated to heuristic graph algorithms

14 Patch-based (overlapping) AMR How to realize AMR? Overlapping patches introduce causality between levels

15 Octree-based (composite) AMR How to realize AMR? Hierarchy is flattened and can be traversed in one pass

16 How to realize AMR? Octree-based AMR Octree maps to cube-like geometry 1:1 relation between octree leaves and mesh elements

17 How to realize AMR? Octree-based AMR Octree maps to cube-like geometry 1:1 relation between octree leaves and mesh elements

18 How to realize AMR? Octree-based AMR Octree maps to cube-like geometry 1:1 relation between octree leaves and mesh elements

19 How to realize AMR? Octree-based AMR Octree maps to cube-like geometry 1:1 relation between octree leaves and mesh elements

20 How to realize AMR? Octree-based AMR Octree maps to cube-like geometry 1:1 relation between octree leaves and mesh elements

21 How to realize AMR? Octree-based AMR Octree maps to cube-like geometry 1:1 relation between octree leaves and mesh elements

22 How to realize AMR? Octree-based AMR Octree maps to cube-like geometry 1:1 relation between octree leaves and mesh elements

23 How to realize AMR? Octree-based AMR Octree maps to cube-like geometry 1:1 relation between octree leaves and mesh elements

24 How to realize AMR? Octree-based AMR Octree maps to cube-like geometry 1:1 relation between octree leaves and mesh elements

25 How to realize AMR? Octree-based AMR Octree maps to cube-like geometry 1:1 relation between octree leaves and mesh elements

26 How to realize AMR? Octree-based AMR Proc 0 Proc 1 Proc 2 Space-filling curve (SFC): Fast parallel partitioning Fast parallel tree algorithms for sorting and searching

27 Synthesis: Forest of octrees From tree... = Partitioning problem solved So far: Only cube-like geometric shapes

28 Synthesis: Forest of octrees...to forest = I Motivation: Geometric flexibility beyond the unit cube I Challenge: Non-matching coordinate systems between octrees

29 p4est forest-of-octrees algorithms Connect SFC through all octrees [1] k 0 k 1 x 0 y 0 k 0 k 1 x 1 p 0 p 1 p 1 p 2 y 1 Minimal global shared storage (metadata) Shared list of octant counts per core (N) p 4 P bytes Shared list of partition markers (k; x, y, z) p 16 P bytes 2D example above (h = 8): markers (0; 0, 0), (0; 6, 4), (1; 0, 4) [1] C. Burstedde, L. C. Wilcox, O. Ghattas (SISC, 2011)

30 p4est forest-of-octrees algorithms p4est core API (for write access ) p4est new: Create a uniformly refined, partitioned forest p4est refine: Refine per-element acc. to 0/1 callbacks p4est coarsen: Coarsen 2 d elements acc. to 0/1 callbacks p4est balance: Establish 2:1 neighbor sizes by add. refines p4est partition: Parallel redistribution acc. to weights p4est random read access (generic / extensible) p4est ghost: Gather one layer of off-processor elements p4est nodes: Gather globally unique node numbering Loop through p4est data structures as needed

31 p4est forest-of-octrees algorithms Weak scalability on ORNL s Jaguar supercomputer Partition Balance Ghost Nodes Percentage of runtime Number of CPU cores Cost of New, Refine, Coarsen, Partition negligible octants; < 10 seconds per million octants per core

32 p4est forest-of-octrees algorithms Weak scalability on ORNL s Jaguar supercomputer Balance Nodes 10 Seconds per (million elements / core) Number of CPU cores Dominant operations: Balance and Nodes scale over 18,360x octants; < 10 seconds per million octants per core

33 p4est forest-of-octrees algorithms p4est is a generic AMR module Rationale: Support diverse numerical approaches Internal state: Element ordering and parallel partition Provide minimal API for mesh modification Connect to numerical discretizations / solvers ( App ) p4est API calls are like MPI collectives (atomic to App) p4est API hides parallel algorithms and communication App p4est: API invokes per-element callbacks App p4est: Access internal state read-only

34 Generic AMR capabilities p4est Enable scalable dynamic AMR What is so different from standard FE?? not much! Use favorite mesh generator to create forest connectivity p4est encapsulates parallel AMR and partitioning Incorporate hanging nodes by additional scatter/gather Physics computation and element matrices are unaffected Matrix-free solvers are unaffected Assembly receives extra couplings

35 Generic AMR capabilities p4est Enable scalable dynamic AMR Convert mesh generator output into forest connectivity Hexahedral mesh generators (e.g. CUBIT): 1-to-1 conversion Tetrahedral mesh generators (e.g. tetgen): 1-to-4 conversion Pick coarsest forest connectivity that respects topology Align to geometry by adaptive octree refinement

36 Generic AMR capabilities p4est Enable scalable dynamic AMR Convert mesh generator output into forest connectivity Output from tetrahedral mesh generator

37 Generic AMR capabilities p4est Enable scalable dynamic AMR Convert mesh generator output into forest connectivity Convert 1 tetrahedron into 4 hexahedra

38 Generic AMR capabilities p4est Enable scalable dynamic AMR Convert mesh generator output into forest connectivity Create discretization on hexahedra as usual

39 Generic AMR capabilities p4est Enable scalable dynamic AMR Convert mesh generator output into forest connectivity Refine recursively as needed

40 Generic AMR capabilities p4est Enable scalable dynamic AMR Convert mesh generator output into forest connectivity Works at scale: Airplane mesh with 270,000 octrees

41 Generic AMR capabilities p4est Enable scalable dynamic AMR Supported Apps so far Rhea (mantle convection, low-order FE, ICES/CalTech) dgea (seismic wave propagation, high-order DG, ICES) Maxwell (electromagnetic scattering, high-order DG, ICES) Ymir (ice sheet dynamics, high-order SE, ICES) deal.ii (generic FE discretization middleware, Texas A&M) ClawPack (hyperbolic conservation laws; work in progress)

42 Generic AMR capabilities p4est Enable scalable dynamic AMR Supported Apps so far Rhea (mantle convection, low-order FE, ICES/CalTech) dgea (seismic wave propagation, high-order DG, ICES) Maxwell (electromagnetic scattering, high-order DG, ICES) Ymir (ice sheet dynamics, high-order SE, ICES) deal.ii (generic FE discretization middleware, Texas A&M) ClawPack (hyperbolic conservation laws; work in progress)...? (put your App here p4est is free software!)

43 Acknowledgements Publications Homepage: Funding NSF DMS, OCI PetaApps, OPP CDI DOE SciDAC TOPS, SC AFOSR HPC Resources Texas Advanced Computing Center (TACC) National Center for Computational Science (NCCS)

Forest-of-octrees AMR: algorithms and interfaces

Forest-of-octrees AMR: algorithms and interfaces Forest-of-octrees AMR: algorithms and interfaces Carsten Burstedde joint work with Omar Ghattas, Tobin Isaac, Georg Stadler, Lucas C. Wilcox Institut für Numerische Simulation (INS) Rheinische Friedrich-Wilhelms-Universität

More information

Parallel adaptive mesh refinement using multiple octrees and the p4est software

Parallel adaptive mesh refinement using multiple octrees and the p4est software Parallel adaptive mesh refinement using multiple octrees and the p4est software Carsten Burstedde Institut für Numerische Simulation (INS) Rheinische Friedrich-Wilhelms-Universität Bonn, Germany August

More information

Adaptive Mesh Refinement (AMR)

Adaptive Mesh Refinement (AMR) Adaptive Mesh Refinement (AMR) Carsten Burstedde Omar Ghattas, Georg Stadler, Lucas C. Wilcox Institute for Computational Engineering and Sciences (ICES) The University of Texas at Austin Collaboration

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 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

p4est: SCALABLE ALGORITHMS FOR PARALLEL ADAPTIVE MESH REFINEMENT ON FORESTS OF OCTREES

p4est: SCALABLE ALGORITHMS FOR PARALLEL ADAPTIVE MESH REFINEMENT ON FORESTS OF OCTREES p4est: SCALABLE ALGORITHMS FOR PARALLEL ADAPTIVE MESH REFINEMENT ON FORESTS OF OCTREES CARSTEN BURSTEDDE, LUCAS C. WILCOX, AND OMAR GHATTAS Abstract. We present scalable algorithms for parallel adaptive

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

Recursive algorithms for distributed forests of octrees

Recursive algorithms for distributed forests of octrees Calhoun: The NPS Institutional Archive Faculty and Researcher Publications Faculty and Researcher Publications 2014-11-18 Recursive algorithms for distributed forests of octrees Isaac, Tobin http://hdl.handle.net/10945/45450

More information

arxiv: v3 [cs.dc] 20 Aug 2015

arxiv: v3 [cs.dc] 20 Aug 2015 RECURSIVE ALGORITHMS FOR DISTRIBUTED FORESTS OF OCTREES TOBIN ISAAC, CARSTEN BURSTEDDE, LUCAS C. WILCOX, AND OMAR GHATTAS arxiv:1406.0089v3 [cs.dc] 20 Aug 2015 Abstract. The forest-of-octrees approach

More information

UNITING PERFORMANCE AND EXTENSIBILITY IN ADAPTIVE FINITE ELEMENT COMPUTATIONS

UNITING PERFORMANCE AND EXTENSIBILITY IN ADAPTIVE FINITE ELEMENT COMPUTATIONS UNITING PERFORMANCE AND EXTENSIBILITY IN ADAPTIVE FINITE ELEMENT COMPUTATIONS Toby Isaac tisaac@ices.utexas.edu The University of Chicago at Austin September 14, 2015 CAAM Colloqium Rice University T.

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

Donna Calhoun. Boise State University

Donna Calhoun. Boise State University Wave propagation algorithms in two dimensions, adaptive refinement and wellbalancing Donna Calhoun Boise State University PASI 2013 Valparaiso, Chile January 2-13 Plan How do these Riemann solvers make

More information

ALPS: A framework for parallel adaptive PDE solution

ALPS: A framework for parallel adaptive PDE solution ALPS: A framework for parallel adaptive PDE solution Carsten Burstedde Martin Burtscher Omar Ghattas, Georg Stadler Tiankai Tu Lucas C. Wilcox Institute for Computational Engineering and Sciences (ICES),

More information

Peta-Scale Simulations with the HPC Software Framework walberla:

Peta-Scale Simulations with the HPC Software Framework walberla: Peta-Scale Simulations with the HPC Software Framework walberla: Massively Parallel AMR for the Lattice Boltzmann Method SIAM PP 2016, Paris April 15, 2016 Florian Schornbaum, Christian Godenschwager,

More information

Parallel, adaptive framework for mapped, multi-block domains

Parallel, adaptive framework for mapped, multi-block domains Parallel, adaptive framework for mapped, multi-block domains Donna Calhoun (Boise State University) Carsten Burstedde (University of Bonn) Randall J. LeVeque (Univ. of WA), Marsha Berger (NYU), David George

More information

HPC Algorithms and Applications

HPC Algorithms and Applications HPC Algorithms and Applications Dwarf #5 Structured Grids Michael Bader Winter 2012/2013 Dwarf #5 Structured Grids, Winter 2012/2013 1 Dwarf #5 Structured Grids 1. dense linear algebra 2. sparse linear

More information

Low-Cost Parallel Algorithms for 2:1 Octree Balance

Low-Cost Parallel Algorithms for 2:1 Octree Balance Low-Cost Parallel Algorithms for 2: Octree Balance Tobin Isaac, Carsten Burstedde, Omar Ghattas Institute for Computational Engineering and Sciences (ICES) The University of Texas at Austin, USA Email:

More information

ForestClaw : Mapped, multiblock adaptive quadtrees

ForestClaw : Mapped, multiblock adaptive quadtrees ForestClaw : Mapped, multiblock adaptive quadtrees Donna Calhoun (Boise State University) Carsten Burstedde (Univ. of Bonn) HPC 3 November 9-13, 2014 KAUST - Saudi Arabia The ForestClaw Project Project

More information

Parallel Unstructured Mesh Generation by an Advancing Front Method

Parallel Unstructured Mesh Generation by an Advancing Front Method MASCOT04-IMACS/ISGG Workshop University of Florence, Italy Parallel Unstructured Mesh Generation by an Advancing Front Method Yasushi Ito, Alan M. Shih, Anil K. Erukala, and Bharat K. Soni Dept. of Mechanical

More information

Scalability of Uintah Past Present and Future

Scalability of Uintah Past Present and Future DOE for funding the CSAFE project (97-10), DOE NETL, DOE NNSA NSF for funding via SDCI and PetaApps, INCITE, XSEDE Scalability of Uintah Past Present and Future Martin Berzins Qingyu Meng John Schmidt,

More information

Predictive Engineering and Computational Sciences. Data Structures and Methods for Unstructured Distributed Meshes. Roy H. Stogner

Predictive Engineering and Computational Sciences. Data Structures and Methods for Unstructured Distributed Meshes. Roy H. Stogner PECOS Predictive Engineering and Computational Sciences Data Structures and Methods for Unstructured Distributed Meshes Roy H. Stogner The University of Texas at Austin May 23, 2012 Roy H. Stogner Distributed

More information

Fast Dynamic Load Balancing for Extreme Scale Systems

Fast Dynamic Load Balancing for Extreme Scale Systems Fast Dynamic Load Balancing for Extreme Scale Systems Cameron W. Smith, Gerrett Diamond, M.S. Shephard Computation Research Center (SCOREC) Rensselaer Polytechnic Institute Outline: n Some comments on

More information

H5FED HDF5 Based Finite Element Data Storage

H5FED HDF5 Based Finite Element Data Storage H5FED HDF5 Based Finite Element Data Storage Novel, Open Source, Unrestricted Usability Benedikt Oswald (GFA, PSI) and Achim Gsell (AIT, PSI) s From: B. Oswald, P. Leidenberger. Electromagnetic fields

More information

Preliminary Experiences with the Uintah Framework on on Intel Xeon Phi and Stampede

Preliminary Experiences with the Uintah Framework on on Intel Xeon Phi and Stampede Preliminary Experiences with the Uintah Framework on on Intel Xeon Phi and Stampede Qingyu Meng, Alan Humphrey, John Schmidt, Martin Berzins Thanks to: TACC Team for early access to Stampede J. Davison

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

Towards a Reconfigurable HPC Component Model

Towards a Reconfigurable HPC Component Model C2S@EXA Meeting July 10, 2014 Towards a Reconfigurable HPC Component Model Vincent Lanore1, Christian Pérez2 1 ENS de Lyon, LIP 2 Inria, LIP Avalon team 1 Context 1/4 Adaptive Mesh Refinement 2 Context

More information

Towards Adaptive Mesh PDE Simulations on Petascale Computers

Towards Adaptive Mesh PDE Simulations on Petascale Computers Towards Adaptive Mesh PDE Simulations on Petascale Computers Carsten Burstedde, Omar Ghattas, Georg Stadler, Tiankai Tu, Lucas C. Wilcox Institute for Computational Engineering & Sciences Jackson School

More information

arxiv: v2 [cs.ms] 2 Oct 2017

arxiv: v2 [cs.ms] 2 Oct 2017 Enhancing speed and scalability of the ParFlow simulation code Carsten Burstedde, Jose A. Fonseca, Stefan Kollet arxiv:1702.06898v2 [cs.ms] 2 Oct 2017 Abstract Regional hydrology studies are often supported

More information

Presented by: Terry L. Wilmarth

Presented by: Terry L. Wilmarth C h a l l e n g e s i n D y n a m i c a l l y E v o l v i n g M e s h e s f o r L a r g e - S c a l e S i m u l a t i o n s Presented by: Terry L. Wilmarth Parallel Programming Laboratory and Center for

More information

Overview of the High-Order ADER-DG Method for Numerical Seismology

Overview of the High-Order ADER-DG Method for Numerical Seismology CIG/SPICE/IRIS/USAF WORKSHOP JACKSON, NH October 8-11, 2007 Overview of the High-Order ADER-DG Method for Numerical Seismology 1, Michael Dumbser2, Josep de la Puente1, Verena Hermann1, Cristobal Castro1

More information

deal.ii: a numerical library to tackle realistic challenges from industry and academia! Luca Heltai SISSA International School for Advanced Studies!

deal.ii: a numerical library to tackle realistic challenges from industry and academia! Luca Heltai SISSA International School for Advanced Studies! deal.ii: a numerical library to tackle realistic challenges from industry and academia! Luca Heltai SISSA International School for Advanced Studies! Adapted from a talk by! Wolfgang Bangerth Texas A&M

More information

Towards Large Scale Predictive Flow Simulations

Towards Large Scale Predictive Flow Simulations Towards Large Scale Predictive Flow Simulations using ITAPS Tools and Services Onkar Sahni a a Present address: Center for Predictive Engineering and Computational Sciences (PECOS), ICES, UT Austin ollaborators:

More information

simulation framework for piecewise regular grids

simulation framework for piecewise regular grids WALBERLA, an ultra-scalable multiphysics simulation framework for piecewise regular grids ParCo 2015, Edinburgh September 3rd, 2015 Christian Godenschwager, Florian Schornbaum, Martin Bauer, Harald Köstler

More information

Parallel Adaptive Tsunami Modelling with Triangular Discontinuous Galerkin Schemes

Parallel Adaptive Tsunami Modelling with Triangular Discontinuous Galerkin Schemes Parallel Adaptive Tsunami Modelling with Triangular Discontinuous Galerkin Schemes Stefan Vater 1 Kaveh Rahnema 2 Jörn Behrens 1 Michael Bader 2 1 Universität Hamburg 2014 PDES Workshop 2 TU München Partial

More information

Parallel Algorithms: Adaptive Mesh Refinement (AMR) method and its implementation

Parallel Algorithms: Adaptive Mesh Refinement (AMR) method and its implementation Parallel Algorithms: Adaptive Mesh Refinement (AMR) method and its implementation Massimiliano Guarrasi m.guarrasi@cineca.it Super Computing Applications and Innovation Department AMR - Introduction Solving

More information

Outline. follows the structure of the report

Outline. follows the structure of the report Outline follows the structure of the report Introduction Mesh-based Modeling of Cuts Finite Element Simulation for Virtual Cutting Numerical Solvers Meshfree Methods Summary & Application Study Discussion

More information

RECURSIVE ALGORITHMS FOR DISTRIBUTED FORESTS OF OCTREES

RECURSIVE ALGORITHMS FOR DISTRIBUTED FORESTS OF OCTREES SIAM J. SCI. COMPUT. Vol. 37, No. 5, pp. C497 C531 c 2015 Society for Industrial and Applied Mathematics RECURSIVE ALGORITHMS FOR DISTRIBUTED FORESTS OF OCTREES TOBIN ISAAC, CARSTEN BURSTEDDE, LUCAS C.

More information

Sustainability and Efficiency for Simulation Software in the Exascale Era

Sustainability and Efficiency for Simulation Software in the Exascale Era Sustainability and Efficiency for Simulation Software in the Exascale Era Dominik Thönnes, Ulrich Rüde, Nils Kohl Chair for System Simulation, University of Erlangen-Nürnberg March 09, 2018 SIAM Conference

More information

Enzo-P / Cello. Formation of the First Galaxies. San Diego Supercomputer Center. Department of Physics and Astronomy

Enzo-P / Cello. Formation of the First Galaxies. San Diego Supercomputer Center. Department of Physics and Astronomy Enzo-P / Cello Formation of the First Galaxies James Bordner 1 Michael L. Norman 1 Brian O Shea 2 1 University of California, San Diego San Diego Supercomputer Center 2 Michigan State University Department

More information

Enzo-P / Cello. Scalable Adaptive Mesh Refinement for Astrophysics and Cosmology. San Diego Supercomputer Center. Department of Physics and Astronomy

Enzo-P / Cello. Scalable Adaptive Mesh Refinement for Astrophysics and Cosmology. San Diego Supercomputer Center. Department of Physics and Astronomy Enzo-P / Cello Scalable Adaptive Mesh Refinement for Astrophysics and Cosmology James Bordner 1 Michael L. Norman 1 Brian O Shea 2 1 University of California, San Diego San Diego Supercomputer Center 2

More information

Asynchronous OpenCL/MPI numerical simulations of conservation laws

Asynchronous OpenCL/MPI numerical simulations of conservation laws Asynchronous OpenCL/MPI numerical simulations of conservation laws Philippe HELLUY 1,3, Thomas STRUB 2. 1 IRMA, Université de Strasbourg, 2 AxesSim, 3 Inria Tonus, France IWOCL 2015, Stanford Conservation

More information

A Scalable Adaptive Mesh Refinement Framework For Parallel Astrophysics Applications

A Scalable Adaptive Mesh Refinement Framework For Parallel Astrophysics Applications A Scalable Adaptive Mesh Refinement Framework For Parallel Astrophysics Applications James Bordner, Michael L. Norman San Diego Supercomputer Center University of California, San Diego 15th SIAM Conference

More information

Structured Grid Generation for Turbo Machinery Applications using Topology Templates

Structured Grid Generation for Turbo Machinery Applications using Topology Templates Structured Grid Generation for Turbo Machinery Applications using Topology Templates January 13th 2011 Martin Spel martin.spel@rtech.fr page 1 Agenda: R.Tech activities Grid Generation Techniques Structured

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

HPC Computer Aided CINECA

HPC Computer Aided CINECA HPC Computer Aided Engineering @ CINECA Raffaele Ponzini Ph.D. CINECA SuperComputing Applications and Innovation Department SCAI 16-18 June 2014 Segrate (MI), Italy Outline Open-source CAD and Meshing

More information

Algorithms and Data Structures for Massively Parallel Generic Adaptive Finite Element Codes

Algorithms and Data Structures for Massively Parallel Generic Adaptive Finite Element Codes Algorithms and Data Structures for Massively Parallel Generic Adaptive Finite Element Codes WOLFGANG BANGERTH, Texas A&M University CARSTEN BURSTEDDE, The University of Texas at Austin TIMO HEISTER, UniversityofGöttingen

More information

Performance Optimization of a Massively Parallel Phase-Field Method Using the HPC Framework walberla

Performance Optimization of a Massively Parallel Phase-Field Method Using the HPC Framework walberla Performance Optimization of a Massively Parallel Phase-Field Method Using the HPC Framework walberla SIAM PP 2016, April 13 th 2016 Martin Bauer, Florian Schornbaum, Christian Godenschwager, Johannes Hötzer,

More information

Radial Basis Function-Generated Finite Differences (RBF-FD): New Opportunities for Applications in Scientific Computing

Radial Basis Function-Generated Finite Differences (RBF-FD): New Opportunities for Applications in Scientific Computing Radial Basis Function-Generated Finite Differences (RBF-FD): New Opportunities for Applications in Scientific Computing Natasha Flyer National Center for Atmospheric Research Boulder, CO Meshes vs. Mesh-free

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

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

Formation of the First Galaxies Enzo-P / Cello Adaptive Mesh Refinement

Formation of the First Galaxies Enzo-P / Cello Adaptive Mesh Refinement Formation of the First Galaxies Enzo-P / ello Adaptive Mesh Refinement James Bordner, Michael L. Norman, Brian O Shea June 20, 2013 Abstract Enzo [8] is a mature and highly successful parallel adaptive

More information

Simulation in Computer Graphics Space Subdivision. Matthias Teschner

Simulation in Computer Graphics Space Subdivision. Matthias Teschner Simulation in Computer Graphics Space Subdivision Matthias Teschner Outline Introduction Uniform grid Octree and k-d tree BSP tree University of Freiburg Computer Science Department 2 Model Partitioning

More information

Scalable Dynamic Adaptive Simulations with ParFUM

Scalable Dynamic Adaptive Simulations with ParFUM Scalable Dynamic Adaptive Simulations with ParFUM Terry L. Wilmarth Center for Simulation of Advanced Rockets and Parallel Programming Laboratory University of Illinois at Urbana-Champaign The Big Picture

More information

Unstructured Grid Numbering Schemes for GPU Coalescing Requirements

Unstructured Grid Numbering Schemes for GPU Coalescing Requirements Unstructured Grid Numbering Schemes for GPU Coalescing Requirements Andrew Corrigan 1 and Johann Dahm 2 Laboratories for Computational Physics and Fluid Dynamics Naval Research Laboratory 1 Department

More information

Graph Partitioning for High-Performance Scientific Simulations. Advanced Topics Spring 2008 Prof. Robert van Engelen

Graph Partitioning for High-Performance Scientific Simulations. Advanced Topics Spring 2008 Prof. Robert van Engelen Graph Partitioning for High-Performance Scientific Simulations Advanced Topics Spring 2008 Prof. Robert van Engelen Overview Challenges for irregular meshes Modeling mesh-based computations as graphs Static

More information

Introduction to parallel Computing

Introduction to parallel Computing Introduction to parallel Computing VI-SEEM Training Paschalis Paschalis Korosoglou Korosoglou (pkoro@.gr) (pkoro@.gr) Outline Serial vs Parallel programming Hardware trends Why HPC matters HPC Concepts

More information

The ITAPS Mesh Interface

The ITAPS Mesh Interface The ITAPS Mesh Interface Carl Ollivier-Gooch Advanced Numerical Simulation Laboratory, University of British Columbia Needs and Challenges for Unstructured Mesh Usage Application PDE Discretization Mesh

More information

Partitioning and Partitioning Tools. Tim Barth NASA Ames Research Center Moffett Field, California USA

Partitioning and Partitioning Tools. Tim Barth NASA Ames Research Center Moffett Field, California USA Partitioning and Partitioning Tools Tim Barth NASA Ames Research Center Moffett Field, California 94035-00 USA 1 Graph/Mesh Partitioning Why do it? The graph bisection problem What are the standard heuristic

More information

The Uintah Framework: A Unified Heterogeneous Task Scheduling and Runtime System

The Uintah Framework: A Unified Heterogeneous Task Scheduling and Runtime System The Uintah Framework: A Unified Heterogeneous Task Scheduling and Runtime System Alan Humphrey, Qingyu Meng, Martin Berzins Scientific Computing and Imaging Institute & University of Utah I. Uintah Overview

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

Collision Detection based on Spatial Partitioning

Collision Detection based on Spatial Partitioning Simulation in Computer Graphics Collision Detection based on Spatial Partitioning Matthias Teschner Computer Science Department University of Freiburg Outline introduction uniform grid Octree and k-d tree

More information

Automatic & Robust Meshing in Fluids 2011 ANSYS Regional Conferences

Automatic & Robust Meshing in Fluids 2011 ANSYS Regional Conferences Automatic & Robust Meshing in Fluids 2011 ANSYS Regional Conferences 1 This is just a taste Note that full 14.0 update webinars of an hour per product will be scheduled closer to the release This presentation

More information

Tools and Primitives for High Performance Graph Computation

Tools and Primitives for High Performance Graph Computation Tools and Primitives for High Performance Graph Computation John R. Gilbert University of California, Santa Barbara Aydin Buluç (LBNL) Adam Lugowski (UCSB) SIAM Minisymposium on Analyzing Massive Real-World

More information

SOFTWARE CONCEPTS AND ALGORITHMS FOR AN EFFICIENT AND SCALABLE PARALLEL FINITE ELEMENT METHOD

SOFTWARE CONCEPTS AND ALGORITHMS FOR AN EFFICIENT AND SCALABLE PARALLEL FINITE ELEMENT METHOD Fakultät Mathematik und Naturwissenschaften, Institut für Wissenschaftliches Rechnen SOFTWARE CONCEPTS AND ALGORITHMS FOR AN EFFICIENT AND SCALABLE PARALLEL FINITE ELEMENT METHOD Der Fakultät Mathematik

More information

Memory Hierarchy Management for Iterative Graph Structures

Memory Hierarchy Management for Iterative Graph Structures Memory Hierarchy Management for Iterative Graph Structures Ibraheem Al-Furaih y Syracuse University Sanjay Ranka University of Florida Abstract The increasing gap in processor and memory speeds has forced

More information

Dynamic Load Partitioning Strategies for Managing Data of Space and Time Heterogeneity in Parallel SAMR Applications

Dynamic Load Partitioning Strategies for Managing Data of Space and Time Heterogeneity in Parallel SAMR Applications Dynamic Load Partitioning Strategies for Managing Data of Space and Time Heterogeneity in Parallel SAMR Applications Xiaolin Li and Manish Parashar The Applied Software Systems Laboratory Department of

More information

13.472J/1.128J/2.158J/16.940J COMPUTATIONAL GEOMETRY

13.472J/1.128J/2.158J/16.940J COMPUTATIONAL GEOMETRY 13.472J/1.128J/2.158J/16.940J COMPUTATIONAL GEOMETRY Lecture 23 Dr. W. Cho Prof. N. M. Patrikalakis Copyright c 2003 Massachusetts Institute of Technology Contents 23 F.E. and B.E. Meshing Algorithms 2

More information

HARNESSING IRREGULAR PARALLELISM: A CASE STUDY ON UNSTRUCTURED MESHES. Cliff Woolley, NVIDIA

HARNESSING IRREGULAR PARALLELISM: A CASE STUDY ON UNSTRUCTURED MESHES. Cliff Woolley, NVIDIA HARNESSING IRREGULAR PARALLELISM: A CASE STUDY ON UNSTRUCTURED MESHES Cliff Woolley, NVIDIA PREFACE This talk presents a case study of extracting parallelism in the UMT2013 benchmark for 3D unstructured-mesh

More information

Efficient Global Element Indexing for Parallel Adaptive Flow Solvers

Efficient Global Element Indexing for Parallel Adaptive Flow Solvers Procedia Computer Science Volume 29, 2014, Pages 246 255 ICCS 2014. 14th International Conference on Computational Science Efficient Global Element Indexing for Parallel Adaptive Flow Solvers Michael Lieb,

More information

Accelerated Earthquake Simulations

Accelerated Earthquake Simulations Accelerated Earthquake Simulations Alex Breuer Technische Universität München Germany 1 Acknowledgements Volkswagen Stiftung Project ASCETE: Advanced Simulation of Coupled Earthquake-Tsunami Events Bavarian

More information

Joint Advanced Student School 2007 Martin Dummer

Joint Advanced Student School 2007 Martin Dummer Sierpiński-Curves Joint Advanced Student School 2007 Martin Dummer Statement of the Problem What is the best way to store a triangle mesh efficiently in memory? The following points are desired : Easy

More information

Low-constant Parallel Algorithms for Finite Element Simulations using Linear Octrees

Low-constant Parallel Algorithms for Finite Element Simulations using Linear Octrees Low-constant Parallel Algorithms for Finite Element Simulations using Linear Octrees Hari Sundar Department of Bioengineering University of Pennsylvania Philadelphia, PA hsundar@seas.upenn.edu Christos

More information

LARGE-SCALE NORTHRIDGE EARTHQUAKE SIMULATION USING OCTREE-BASED MULTIRESOLUTION MESH METHOD

LARGE-SCALE NORTHRIDGE EARTHQUAKE SIMULATION USING OCTREE-BASED MULTIRESOLUTION MESH METHOD 16th ASCE Engineering Mechanics Conference July 16-18, 3, University of Washington, Seattle LARGE-SCALE NORTHRIDGE EARTHQUAKE SIMULATION USING OCTREE-BASED MULTIRESOLUTION MESH METHOD Eui Joong Kim 1 Jacobo

More information

Effective adaptation of hexahedral mesh using local refinement and error estimation

Effective adaptation of hexahedral mesh using local refinement and error estimation Key Engineering Materials Vols. 243-244 (2003) pp. 27-32 online at http://www.scientific.net (2003) Trans Tech Publications, Switzerland Online Citation available & since 2003/07/15 Copyright (to be inserted

More information

τ-extrapolation on 3D semi-structured finite element meshes

τ-extrapolation on 3D semi-structured finite element meshes τ-extrapolation on 3D semi-structured finite element meshes European Multi-Grid Conference EMG 2010 Björn Gmeiner Joint work with: Tobias Gradl, Ulrich Rüde September, 2010 Contents The HHG Framework τ-extrapolation

More information

Solving Partial Differential Equations on Overlapping Grids

Solving Partial Differential Equations on Overlapping Grids **FULL TITLE** ASP Conference Series, Vol. **VOLUME**, **YEAR OF PUBLICATION** **NAMES OF EDITORS** Solving Partial Differential Equations on Overlapping Grids William D. Henshaw Centre for Applied Scientific

More information

Towards a Unified Framework for Scientific Computing

Towards a Unified Framework for Scientific Computing Towards a Unified Framework for Scientific Computing Peter Bastian 1, Marc Droske 3, Christian Engwer 1, Robert Klöfkorn 2, Thimo Neubauer 1, Mario Ohlberger 2, Martin Rumpf 3 1 Interdisziplinäres Zentrum

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

Exploring unstructured Poisson solvers for FDS

Exploring unstructured Poisson solvers for FDS Exploring unstructured Poisson solvers for FDS Dr. Susanne Kilian hhpberlin - Ingenieure für Brandschutz 10245 Berlin - Germany Agenda 1 Discretization of Poisson- Löser 2 Solvers for 3 Numerical Tests

More information

Image-Space-Parallel Direct Volume Rendering on a Cluster of PCs

Image-Space-Parallel Direct Volume Rendering on a Cluster of PCs Image-Space-Parallel Direct Volume Rendering on a Cluster of PCs B. Barla Cambazoglu and Cevdet Aykanat Bilkent University, Department of Computer Engineering, 06800, Ankara, Turkey {berkant,aykanat}@cs.bilkent.edu.tr

More information

Automatic & Robust Meshing in Fluids 2011 ANSYS Regional Conferences

Automatic & Robust Meshing in Fluids 2011 ANSYS Regional Conferences Automatic & Robust Meshing in Fluids 2011 ANSYS Regional Conferences 1 Automatic & Robust Meshing Assembly Meshing Assembly Meshing enables dramatically reduced time to mesh for typical CAD models by eliminating

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

Using Sonnet in a Cadence Virtuoso Design Flow

Using Sonnet in a Cadence Virtuoso Design Flow Using Sonnet in a Cadence Virtuoso Design Flow Purpose of this document: This document describes the Sonnet plug-in integration for the Cadence Virtuoso design flow, for silicon accurate EM modelling of

More information

A Framework for Online Inversion-Based 3D Site Characterization

A Framework for Online Inversion-Based 3D Site Characterization A Framework for Online Inversion-Based 3D Site Characterization Volkan Akcelik, Jacobo Bielak, Ioannis Epanomeritakis,, Omar Ghattas Carnegie Mellon University George Biros University of Pennsylvania Loukas

More information

Introduction to Finite Element Modelling in Geosciences

Introduction to Finite Element Modelling in Geosciences Spring Semester 2012 651-4144-00L Introduction to Finite Element Modelling in Geosciences August 5-9, 2013 Dave May (dave.may@erdw.ethz.ch) Marcel Frehner (marcel.frehner@erdw.ethz.ch) Thomas Philippe

More information

Scene Management. Video Game Technologies 11498: MSc in Computer Science and Engineering 11156: MSc in Game Design and Development

Scene Management. Video Game Technologies 11498: MSc in Computer Science and Engineering 11156: MSc in Game Design and Development Video Game Technologies 11498: MSc in Computer Science and Engineering 11156: MSc in Game Design and Development Chap. 5 Scene Management Overview Scene Management vs Rendering This chapter is about rendering

More information

Computational Fluid Dynamics with the Lattice Boltzmann Method KTH SCI, Stockholm

Computational Fluid Dynamics with the Lattice Boltzmann Method KTH SCI, Stockholm Computational Fluid Dynamics with the Lattice Boltzmann Method KTH SCI, Stockholm March 17 March 21, 2014 Florian Schornbaum, Martin Bauer, Simon Bogner Chair for System Simulation Friedrich-Alexander-Universität

More information

Enabling In Situ Viz and Data Analysis with Provenance in libmesh

Enabling In Situ Viz and Data Analysis with Provenance in libmesh Enabling In Situ Viz and Data Analysis with Provenance in libmesh Vítor Silva Jose J. Camata Marta Mattoso Alvaro L. G. A. Coutinho (Federal university Of Rio de Janeiro/Brazil) Patrick Valduriez (INRIA/France)

More information

A Scalable GPU-Based Compressible Fluid Flow Solver for Unstructured Grids

A Scalable GPU-Based Compressible Fluid Flow Solver for Unstructured Grids A Scalable GPU-Based Compressible Fluid Flow Solver for Unstructured Grids Patrice Castonguay and Antony Jameson Aerospace Computing Lab, Stanford University GTC Asia, Beijing, China December 15 th, 2011

More information

Implicit Low-Order Unstructured Finite-Element Multiple Simulation Enhanced by Dense Computation using OpenACC

Implicit Low-Order Unstructured Finite-Element Multiple Simulation Enhanced by Dense Computation using OpenACC Fourth Workshop on Accelerator Programming Using Directives (WACCPD), Nov. 13, 2017 Implicit Low-Order Unstructured Finite-Element Multiple Simulation Enhanced by Dense Computation using OpenACC Takuma

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

A PARALLEL GEOMETRIC MULTIGRID METHOD FOR FINITE ELEMENTS ON OCTREE MESHES

A PARALLEL GEOMETRIC MULTIGRID METHOD FOR FINITE ELEMENTS ON OCTREE MESHES A PARALLEL GEOMETRIC MULTIGRID METHOD FOR FINITE ELEMENTS ON OCTREE MESHES RAHUL S. SAMPATH AND GEORGE BIROS Abstract. In this article, we present a parallel geometric multigrid algorithm for solving elliptic

More information

Massively Parallel Phase Field Simulations using HPC Framework walberla

Massively Parallel Phase Field Simulations using HPC Framework walberla Massively Parallel Phase Field Simulations using HPC Framework walberla SIAM CSE 2015, March 15 th 2015 Martin Bauer, Florian Schornbaum, Christian Godenschwager, Johannes Hötzer, Harald Köstler and Ulrich

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 Georgia Institute of Technology, Atlanta,

More information

From Physical Modeling to Scientific Understanding An End-to-End Approach to Parallel Supercomputing

From Physical Modeling to Scientific Understanding An End-to-End Approach to Parallel Supercomputing From Physical Modeling to Scientific Understanding An End-to-End Approach to Parallel Supercomputing Tiankai Tu Hongfeng Yu Leonardo Ramirez-Guzman Jacobo Bielak Omar Ghattas Kwan-Liu Ma David R. O Hallaron

More information

Principles of Parallel Algorithm Design: Concurrency and Mapping

Principles of Parallel Algorithm Design: Concurrency and Mapping Principles of Parallel Algorithm Design: Concurrency and Mapping John Mellor-Crummey Department of Computer Science Rice University johnmc@rice.edu COMP 422/534 Lecture 3 17 January 2017 Last Thursday

More information

High-Performance Computational Electromagnetic Modeling Using Low-Cost Parallel Computers

High-Performance Computational Electromagnetic Modeling Using Low-Cost Parallel Computers High-Performance Computational Electromagnetic Modeling Using Low-Cost Parallel Computers July 14, 1997 J Daniel S. Katz (Daniel.S.Katz@jpl.nasa.gov) Jet Propulsion Laboratory California Institute of Technology

More information

arxiv: v1 [cs.ms] 8 Aug 2018

arxiv: v1 [cs.ms] 8 Aug 2018 ACCELERATING WAVE-PROPAGATION ALGORITHMS WITH ADAPTIVE MESH REFINEMENT USING THE GRAPHICS PROCESSING UNIT (GPU) XINSHENG QIN, RANDALL LEVEQUE, AND MICHAEL MOTLEY arxiv:1808.02638v1 [cs.ms] 8 Aug 2018 Abstract.

More information

Load Balancing and Data Migration in a Hybrid Computational Fluid Dynamics Application

Load Balancing and Data Migration in a Hybrid Computational Fluid Dynamics Application Load Balancing and Data Migration in a Hybrid Computational Fluid Dynamics Application Esteban Meneses Patrick Pisciuneri Center for Simulation and Modeling (SaM) University of Pittsburgh University of

More information

State of the Art in Electromagnetic Modeling for the Compact Linear Collider

State of the Art in Electromagnetic Modeling for the Compact Linear Collider State of the Art in Electromagnetic Modeling for the Compact Linear Collider Arno Candel, Andreas Kabel, Lie-Quan Lee, Zenghai Li, Cho Ng, Greg Schussman and Kwok Ko SLAC National Accelerator Laboratory

More information