recent advances in high performance computing for ...€¦ · recent advances in high performance...

73
Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho [email protected] High Performance Computing Center COPPE/Federal University of Rio de Janeiro www.nacad.ufrj.br

Upload: others

Post on 16-Jun-2020

1 views

Category:

Documents


0 download

TRANSCRIPT

Page 1: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Recent Advances in High Performance

Computing for Multiphysics Problems

Alvaro Coutinho

[email protected]

High Performance Computing Center

COPPE/Federal University of Rio de Janeiro

www.nacad.ufrj.br

Page 2: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Contents

Who we are and what we do

Multiphysics: What is it?

Algorithms and Software

Parallel Implementation strategies and related topics

Final Remarks

Page 3: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

WHO WE ARE AND

WHAT WE DO

Page 4: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

COPPE/UFRJ Innovation Ecosystem

Page 5: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

NACAD´s Mission

High Performance Computing in Engineering and Computer

Science

To provide and operate infrastructure for advanced computing

Develop and support multidisciplinary projects R & D of

relevance, especially in:

– Energy: Oil and Gas, Electric

– Civil, Mechanical and Materials Engineering

– Environment, Meteorology and Oceanography

– Computing, Database and Data Mining

– Biological Sciences

COPPE hosts 1st Intel’s IPCC in LA

Page 6: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Brazil in TOP500 List, Nov 2013

http://www.top500.org Lists the top 500 supercomputers; Updated in 06/XX and 11/XX

Page 7: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

BRIC’s Historical Trends in TOP500

Page 8: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

MULTIPHYSICS: WHAT IS IT?

Page 9: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

According Keyes et al (IJHPC Apps,

2013), a multiphysics system consists

of more than one component governed

by its own principle(s) for evolution or

equilibrium, typically conservation or

constitutive laws

Multiphysics systems are analyzed by

decomposition or breakdown.

Coupling occurs in the bulk (e.g.,

through source terms or constitutive

relations that are active in the

overlapping domains of the individual

components) or it occurs over an

idealized interface that is lower

dimensional.

From Felippa, Park and Farhat (CMAME, 2002)

Multiphysics Basics

Page 10: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

A multiphysics system is characterized as 2-field, 3-field, etc.

Fields are discretized in space and time. A field partition is a field-

by-field decomposition of the space discretization. A splitting is a

decomposition of the time discretization of a field within its time

interval.

Partitioning may be algebraic or differential.

Algebraic partitioning; coupled system is spatially discretized and

then decomposed.

Differential partitioning: decomposition is done first and each field

is then discretized.

Multiphysics Basics (cont’d)

Page 11: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Examples of Coupled Multiphysics

Problems

Fluid-Structure Interaction (2-field)

Thermal-Structure Interaction (2-field)

Control-Structure Interaction (2-field)

Solid-Fluid-Thermal Interaction (3-field)

Fluid-Structure-Combustion (3-field)

Chemo-Thermal-Structure (3-field)

Fluid-Porous Media-Thermal (3-field)

Fluid-Fluid Interaction (n-field)

Fluid-Particle Interaction (1 field, n-particles)

etc

Wide ranges of interacting length and time scales are present, such as in

turbulence, micromechanics, failure and damage, etc.

Page 12: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Strategies to Multiphysics System

Simulation

Monolithic or Simultaneous Treatment – The whole problem is treated as a monolithic entity, advancing all fields

simultaneously in time.

Partitioned Treatment Field models are computationally treated as isolated entities that are

separately stepped in time.

Interaction effects are viewed as forcing effects that are communicated between the individual components.

Monolithic and Partitioned Approaches are General We prefer the partitioned approach, because it allows the coupling of

different programs, maybe written by different teams, etc.

However, we may see degradation of time-stepping stability in linear problems. Accuracy can be improved by iterating the state between fields. However, these iterations can be more costly than simply to reduce stepsize.

Page 13: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

EXAMPLE COMPUTATIONS

Page 14: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

FPSO under Wave Action

Elias et al, A stabilized edge-based finite element approach to wave-structure interaction assessment,

ASME 32th OMAE 2013 Nantes, France, 9 - 14 June 2013

Water/Air/Structure

Page 15: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Petrobras’s sedimentation tank

Camata et al, FEM Simulation of Coupled Flow and Bed Morphodynamic Interactions due to Sediment Transport

Phenomena, Journal of Computational Science and Technology, JSME, 2013

Fluid/Fluid/Sediment deposition

Page 16: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Petrobras sedimentation tank

Page 17: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Horizontal permeability distribution in B2

Profiling Reservoir Simulators: SLB Benchmark B2

Cavalcante Filho et al, Increasing Performance of Commercial Reservoir Simulators by Core Skew Allocation,

PARCFD 2012, Atlanta, USA

Multiphase flow in porous media

0

1000

2000

3000

4000

8 16 32 64 128 256 512

Tim

e(seconds)

#cores

Galileu8cores/node 4cores/node

Page 18: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

ALGORITHMS AND

SOFTWARE

Page 19: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

What is large?

Large in size unstructured grids with 108-109 elements (cells)

Large in coupling many fields interacting

Large in physical parameters different viscosities, densities, …

Large in control parameters tolerances, solver options, etc

Large in complexity several softwares, human intervention,

reproducibility, uncertainty quantification, data provenance.

What do we have to worry about besides multiphysics itself?

– Efficient algorithms and solvers

– Data structures, data storage and management

– Parallel mesh generation and adaptivity

– Visualization

Page 20: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Challenges on Multiphysics Algorithms and Software* (1)

Modern simulation software is complex:

– Implicit numerical methods

– Massively parallel computers

– Adaptive methods

– Multiple, coupled physical processes

There are a host of existing software libraries that excel at treating

various aspects of this complexity.

Leveraging existing software whenever possible is the most efficient

way to manage this complexity.

* Adapted from libMesh library

Page 21: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Challenges on Multiphysics Algorithms and Software (2)

Modern simulation software is multidisciplinary:

– Physical Sciences

– Engineering

– Computer Science

– Applied Mathematics

– Etc …

It is not reasonable to expect a single person to have all the

necessary skills for developing & implementing high-performance

numerical algorithms on modern computing architectures.

Teaming is a prerequisite for success.

Page 22: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Single Simulation Code: Major Components

Pre-processing

Input data

Time integration loop

Nonlinear iteration loop

Form system of linear equations

Solve system of linear equations

End NL loop

Update time step

Output results

End time loop

Post-processing

Visualization

Complexity O(n4/3), n #unknowns

Optimal solvers require O(n) work per time step, and time accurate integration often implies O(n1/3 ) time steps.

Page 23: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Main Computational Kernels

Forming system matrices and RHS

Focus here is on implicit methods with iterative solvers (PCG,

PGMRES)

CSR, Element by Element (Cell by Cell) or Edge by Edge loops

; ;k k

k k

J x R J J R R

Page 24: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Example: Finite Element Method

Unstructured grid method

characterized by:

– Discontinuous data

– Gather/scatter operations

– Random memory access

– Data dependencies

Page 25: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Data Structures are Grid-based

row i

Finite Element Mesh

Nodal Graph

node i

J =

EBE, EDE or CSR; all data structures lead to problems with sparse Jacobian matrices; many tasks can leverage off an efficient set of tools for manipulating distributed sparse data structures

Page 26: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Meshes, Graphs and Matrices

Sparse Matrix

geometrical representation relational representation algebraic representation

Finite difference grid Dual graph (cells)

Grid points graph

Unstructured mesh

Dual graph (elements) Nodal graph

Page 27: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

SIMULATION SOFTWARE

Page 28: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

EdgeCFD®

Fluid Flow/Free-surface/FSI Solver

28

General:

– Edge based data structure. “EDE has been proving to be more efficient than other FEM data structures like CSR or EBE”

– Segregated predictor-multicorrector time marching;

– Adaptive time stepping with PID controller;

– Supports hybrid parallelism (MPI, OpenMP or both at the same time);

– Unstructured grids with linear tetrahedra for velocity, pressure and scalar transport;

– Mesh partitioning performed by Metis or ParMetis;

– Best data reordering defined by EdgePack® in a preprocessing phase;

– Thermal-flow coupling with Boussinesq approximation; FSI

– Input/Output file formats: ANSYS/Ensight/Paraview, neutral files, Xdmf/hdf5

Incompressible Flow:

– SUPG/PSPG/LSIC stabilized finite element method in Eulerian or ALE frames

– Fully coupled u-p system (4-dofs per node/non-symmetric);

– Inexact Newton-GMRES;

– LES (Smagorinsky, Dynamic Smagorinsky), ILES, RB-VMS

– Newtonian or non-Newtonian flows (Power Law, Bingham and Hershel-Buckley)

Transport:

– SUPG/CAU/YZBeta stabilized finite element method in Eulerian and ALE frames

– Supports free-surface flows through Volume-Of-Fluid and Level-Sets.

– (UFMM) Unstructured Fast Marching Method for fast computation of signed distance functions

– PDD: Parallel dynamic deactivation. “Restrict the computation only in regions with high solution gradients”

Particulate gravity flow

Floating bodies

Wave-structure interaction

Page 29: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Ansys Classic, ICEM-CFD, CFX and/or GMSH

– Computational model

– Mesh Generation

Preprocessor (EdgeCFDPre)

1. Takes a serial mesh;

2. Creates partitions with Metis (could be Scotch…)

3. Extracts edges and reorders data with EdgePack

4. Stores data prepared to solver

Solver (EdgeCFDSolver)

ParaView, VisIt, Ensight

– Visualization: Ensight, Xdmf/HDF5 or Parallel VTK

Workflow management and

provenance by Chiron

Blue: “Home made” code Green: Third party code

EdgeCFD Software Stack

Page 30: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

libMesh

High level interface for finite

element analysis (Kirk et al., Eng.

with Computers, 2006)

Keep focus on the physical problem

instead of the computational

aspects related to the adaptive

mesh refinement/coarsening and

parallel computing

Developed initially at UT Austin

Available at:

http://libmesh.sourceforge.net/

libMesh interfaces

Page 31: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

AMR/C

libMesh utilizes a statistical scheme

(Kirk et al., Eng. with Computers,

2006)

– Kelly’s error estimator

As the simulation goes on, the

statistical distribution of the error

spreads and then the refinement

and coarsening begin

As the solution reaches equilibrium,

the error distribution reaches

steady state and then the adaptive

process stops

Probability density function. Kirk et al., 2006

Page 32: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

SMART ALGORITHMS

Nonlinear solvers and adaptive time step control

Page 33: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Advanced Nonlinear Solver

Page 34: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Adaptive Time Step Control

How to speed-up time marching schemes?

– Adapting time step according to the solution evolution;

– Track the solution with interventions (feedback) when needed.

– Particularly useful in stiff systems

Key idea:

– Tracking × Feedback Controllers

– Theory on ODE solvers

• G. Soderlind, Automatic control and adaptive time-stepping. Numerical Algorithms,

2002; 31:281–310

– Application on PDE’s:

• A. M. P. Valli, G. F. Carey and A. L. G. A. Coutinho, Control strategies for timestep selection in finite element simulation of incompressible flows and coupled reaction–convection–diffusion processes, IJNMF, 2005.

Page 35: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Coupled Fluid Flow and Heat Transfer

Rayleigh-Benard 4:1:1 Container

MESH SIZE:

Elements..............: 93,925

Nodes.................: 21,384

Edges.................: 120,306

Flow equations........: 70,536

Transport equations...: 19,008

DIMENSIONLESS NUMBERS:

Prandtl...............: 0.72

Rayleigh..............: 30,000

See: A. M. P. Valli, R. N. Elias, G. F. Carey, A. L. G. A. Coutinho, PID adaptive control of incremental and arclength

continuation in nonlinear applications, Int. J. Numer. Meth. Fluids 2009; 61:1181–1200

Page 36: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Adaptive Time Stepping and IN Performance

Max IN Tol CFL min CFL max SS time time steps wall time

0.001 2 10 0.5686 109 1110.49

5 0.2410 90 855.42

2 0.1829 171 1184.81

0.1 2 10 0.5635 108 803.89

5 0.2418 90 637.71

2 0.1840 172 1017.02

0.99 2 10 0.7436 142 1652.06

5 0.2417 90 991.96

2 0.1839 172 1501.97

SS Tolerance: 10-5 Transport P-GMRES Tol: 10-3 # Krylov Space Vectors: 25

Page 37: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

PARALLEL COMPUTATIONS

Page 38: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Standard Approach:

– Takes a mesh and give it to a partitioner (Metis, Scotch, Jostle…)

– Once partitioned, keeps the data parallel (forever…)

– Global IDs Local IDs

– Each process records its own files

– Shared information is synchronized by p2p non-blocking communications

– No ghost/halo information employed

Distributed Memory Parallelism

Page 39: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Standard blocked loops to remove memory dependency

!$OMP PARALLEL DO

do i=1,nel

! retrieve element nodes

x(no) = x(no) + a

enddo

!$OMP END PARALLEL DO

ielm = 0

do icor = 1, ncores

nvec = ielblk(icor)

!$OMP PARALLEL DO

do i = ielm+1, ielm+nvec

! Retrieve element nodes

x(no) = x(no) + a

enddo

!$OMP END PARALLEL DO

ielm = ielm+nvec

enddo

Threaded Parallelism

Page 40: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

iside = 0

DO iblk = 1, nedblk

nvec = ia_edblk(iblk)

!dir$ ivdep

!$OMP PARALLEL DO

DO ka = iside+1, iside+nvec, 1

...MATVEC computations...

ENDDO

!$OMP END PARALLEL DO

ENDDO

...over interface nodes...

#ifdef MPICODE

call MPI_AllReduce

#endif

Edge-by-Edge

Hybrid Matrix-Vector Product

Page 41: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

MPI Collective Communications

Page 42: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

P2P Subdomain Communication

(a) Mesh Partition (b) Communication Graph

Master-Slave subdomain relationship

Exchange information between neighboring processors implemented

in two stages:

(i) slaves processes send their information to be operated by masters

(ii) solution values are copied from masters to slaves.

EdgeCFD uses non-blocking send and receive MPI primitives

See also: Karanam, Jansen, Whiting, Geometry based pre-processor for parallel

fluid dynamic simulations using a hierarchical basis, Engineering with Computers (2008)

Page 43: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Rayleigh-Benard 4:1:1 - 501×125×125 mesh

Elements..............: 39,140,625

Nodes.................: 7,969,752

Edges.................: 43,833,636

Flow equations........: 31,879,008

Temperature equations.: 7,642,824

Time steps............: 2,954

Mesh generation: SGI Altix 450 128GB RAM

Solver: SGI Altix ICE 8200, 128 cores, Cluster Dell 64 cores, MPI-P2P

Page 44: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

P2P Communication Graph

SGI Altix ICE 8200, 128 cores

Arrows indicate communication direction in sending operations.

Communication is reversed in receiving

Graph visualization tool: Nodes3D, http://brainmaps.org/index.php?p=desktop-apps-nodes3d

Page 45: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

TAU Parallel Profiling

SGI Altix ICE 8200, 128 cores

Page 46: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Cluster Dell, 64 cores, process placement

Time spent in 10 time steps

Communication graph

Page 47: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

AMR/C and Solver Performance

Implicit time integration schemes require a solution of large and sparse linear system

Krylov subspace methods + preconditioning strategies

– Incomplete LU factorizations methods

– Powerful method in terms to improve convergence

– Complex parallel implementation

Making ILU more suitable for parallel architectures

– Block preconditioners with local ILU factorizations

– Domain decomposition preconditioners: Additive-Schwartz and

– Block Jacobi

How the choice of block ILU affects the simulation performance using AMR/C using

different unknowns orderings

Page 48: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

The three-dimensional deformation problem

SUPG FEM with linear tets

Page 49: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Results 3D deformation problem

Page 50: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Results 3D deformation problem

Page 51: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Results 3D deformation problem

1Each compute node has two Intel Quad-Core 2.66GHz, 8MB L2 cache on-die and

16GB of memory

Page 52: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Nonzeros allocated using ILU(1) preconditioner and 64

processors

Page 53: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

53

Geometry, boundary and initial conditions:

Simulation Domain:

No-slip on top and bottom walls; slip on all others

Half right filled with “heavy” fluid and left half filled with “light” fluid

]1,1[x]3,0[x]15,15[

1h 0l

71.0Sc6101.5 Gr

025.0t

Dimensionless parameters:

Run on 240 cores, Viz with ParaView, parallel

rendering

GMRES(30)

BILU(1)

RCM reordering See also Camata et al, IJNMF, 2012

Planar 3D Lock-Exchange with AMR/C

Page 54: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Planar 3D Lock-Exchange with AMR/C

Rossa & Coutinho, Parallel adaptive simulation of gravity currents on the lock-exchange

problem, Computer and Fluids, 2013

Page 55: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Front evolution

X = x

Froude Number

b

f

u

uFr

Work Fr

Present 0.505

Elias et al. 0.579

Härtel et al. 0.576

Cantero et al. 0.570

Experimental ~0.48 0

2

4

6

8

10

12

0 2 4 6 8 10 12 14 16 18 20

X

t

Present

Elias et al.

Experimental

Cantero et al.

Planar 3D Lock-Exchange with AMR/C

Page 56: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Chemical convection benchmark w/ AMR/C:

Stokes flow Initial mesh: locally refined mesh 133,120 hex-8

NL tolerance: 4100.1

Initial interface

xxy cos02.02.0)(

9142.0

Equivalent uniform mesh 2,097,152 (128^3) hex-8

Domain:

,01,0,0

0.1Re

01.0t

Dimensionless Parameters

0.1Ri

D. F. M. Vasconcelos, A. L. Rossa and A. L. G. A. Coutinho, A residual-based Allen–Cahn phase field model for

the mixture of incompressible fluid flows, IJNMF, 2014.

No-slip

Free-slip

Free-slip

No-slip

Page 57: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Chemical convection benchmark w/ AMR/C

Heavy fluid below the

interface

Freeman et al, 2005, mesh 323 Present Solution, AMR, VoF+YZβ

Page 58: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

GETTING BIGGER AND

BIGGER

Page 59: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

High Fidelity Parallel Mesh Generation

Experiments conducted in Stampede at TACC UT-Austin, USA

Igor T. Ghisi, Jose J. Camata and Alvaro L. G. A. Coutinho, Impact of tetrahedralization on

parallel conforming octree mesh generation, IJNMF, 2014

Page 60: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

• Gofasttotheresultsyouneedtoanalyze

ü Naviga onoverdataresults(par al)addedbyprovenance(log)

ü Filterresultsandstageoutonlythedatayouneedtoanalyze

ü Interactwithaweb-baseduserinterface

• Exportandanalyzepar alresultstotakedecisions

ü Efficientdataconsolida onanddatastagingfeaturestoaggregateandstageoutonlyrelevantinforma on

ü Usesta s calandvisualiza ontoolsempoweredbyprovenancedata

ü Drawpreliminaryconclusions

Visualiza onandUser-Steering

Introduc on

References

• Large-ScaleExperimentsScenarioü BlackBoxexecu on

§ Useofdifferentcomputerprogramsandscripts§ Dataheterogeneityandgranularity§ Hardtofollowtheexecu on

ü Hardtovisualizepar alresults§ Alotofinforma ontobefiltered§ Traceabilityofwhichinputproduceseachoutput§ Someresultsmaynotbeuseful§ Dataandmeta-dataassocia on

§ FragmentedData§ Relevanceofdata§ Eachanalysismayfocusonasubsetoftheobtainedoutputs

§ Laboriousdatatransfers• Scien ficWorkflows

ü Improvesexperimentmanagementü Mayprovidedatauniformityü ProvenanceData

• Provenanceisakeyfeatureü Keepstrackofeverythingthathappensduring

experimentexecu onü Alogthatcanbequeriedü Allowsforhigh-levelanddomain-specificqueries

§ WhatarethemaximumvaluesforvelocityandpressureonagivenCFDsimula on?

ü Apowerfulassocia on:Experimentmeta-datawithstrategicexperimentalresults§ Run meanalysis§ Goodfor me-consumingexperiments

ü User-steeringforconvergenceanalysis § Userinteractswithdataofinterestatrun me§ Interfereintheworkflowexecu ontoadjust

Large-ScaleScien ficDataVisualiza onusingProvenance

• Visualizesexperimentdatathroughtheworkflow

ü Displaysprovenancedataforinforma onbrowsing

ü ProvenancedatacollectedbyChiron[8]orSciCumulus[9]workflowengines

• Allowsforselec onsandfilteringoverprovenancedata

ü Letscien stsselectjusttheresultsthatinterestthem

• Nestoutputfilestovisualizefragmenteddataformats

ü Pu ngtagsonresultfilesenablesselec vedatastagingfordataformatsthatstoreinforma onacrossseparatefilesbutneedthemtogetherduringvisualiza on.

ü Thescien stscanspecifyac onstovisualizedatawithspecifictags

§ Theac oncanbeprogramsorscriptsdefinedbythescien sts

§ Scien stscanchoosetoruntheac ononserversideorclientside

• Stage-outonlythedatathescien stsselected

• Displaytheresultslocallyoronadisplaytechnologies

ü Integra onwith ledwalldisplaystechnologies

ü CurrentlyimplementedtouseTACCDisplayCluster

ü Canbeextendedtootherpla ormssuchasCGLXorSAGE

ü Integra onwithParaview

• MonitorandAnalyzeworkflowexecu onü Beawareofthecurrentworkflowstatusü Iden fyandsolveproblemsduringexecu onü Recoverfromfailuresandmistakesü Reduce mespentinprocessinglow-qualitydataü Cutexecu on meandreducefinancialcosts

§ Stagedataoutcanbecostly!§ Remoteclusters§ Cloudenvironments

• Usehigh-resolu ondisplayenvironmentsü Visualizemul pleresultstoestablishcomparisons

§ Onparametersexplora onscenariosü Analyzehighlydetailedimagesandsimula onsü Cantakeadvantageofavailable leddisplaytechnologies

suchasTACCDisplayCluster[1],SAGE[2],CGLX[3],andParaview[4]

Felipe Horta, Jonas Dias, Renato Elias, Daniel de Oliveira,

Alvaro Coutinho and Marta Mattoso

COPPE, Federal University of Rio de Janeiro, Brazil

Fluminense Federal University, Brazil

Prov-Vis: Large-Scale Scientific Data Visualization using Provenance

• VisTrails

ü Strongsupportforvisualiza on&provenance

ü Visualiza onon ledwalldisplays

ü NoHPCsupportintegratedtovisualizedatadirectlyfromclustersorclouds

• Swi /Turbine[10]orPegasus[11]

ü HPCinverylargescalewithprovenance

ü Norun meprovenancesupport

ü Hardtoenrichvisualresultswithprovenance

• ParaViewCo-ProcessingLibraries[12]

ü NotrelatedwithSWfMS

• Nosolu onthatintegratesHPCexecu onwithvisualiza onenrichinganalysiswithrun meprovenancedata

RelatedWork

[2]

[3]

[4]

21

3

4

ü WearecurrentlyexploringexperimentsfromCFD[5]withUncertaintyQuan fica onandBioinforma cs[6][7].

• Scien ficWorkflowManagementSystems(SWfMS)

ü DifferentflavorsofSWfMS

ü WithVisualiza onSupport

§ VisTrails[2]

§ Integra onwithvisualiza onlibraries

§ Allowsvisualiza onon ledwalldisplays

§ NoHPCsupportintegratedtovisualizedatadirectlyfromclustersorclouds

ü WithHighPerformanceCompu ngSupport

• WebinterfaceconnectedtoProvenanceDatabaseandvisualiza onenvironment

ü Richandinterac veinterface

ü Navigatethroughitsac vi esandi/odata

ü Filteringop onstoselectthedesiredresults

ü Stagedataoutoftheexecu onenvironment

ü Text,images,PDF,videoandParaviewvisualiza on

• Webserviceinthevisualiza onclustertodisplaystagedoutdataintheTiledWallDisplay

ü ImplementedasaWebService

ü Interfaceaccessedbythewebmoduleinrun me

ü Canalsostagedataoutoftheexecu onenvironment

ü Pluggabletosupportdifferent ledwalldisplaysmiddlewares.

Features Architecture

4 Conclusion 5• WebApplica ontovisualizeexperimentresultsenrichedwithprovenancedata

ü Navigatethroughdata,selectdesiredresultsandvisualizeitonyourworksta onoronyour ledwalldisplayenvironment.

• Keeptrackofwhichdataproducedeachresult

ü Queryprovenancedataandvisualizerelatedresults

• Organizeandassociatedatausingtags

ü Provideapersonalizedviewoftheresults

ü Easiertonavigateonlarge-scaledatasets

ü Goodforfragmentedoutputs

ü Personalizedac onstovisualizedataonspecificformats

3

[10]

ü Ac onintagscanbeoneofparaview'srecordedscriptsthatreadstheexperimentresultsandproducesavideo,forexample.

[11] [12]

[9][8]

[4][3][2][1]

ü Provenanceenrichedvisualiza onmaysupportrun meandsystema canalysisonresultsfromlarge-scaleexperiments.

Nodes with 8 cores

Mesh Processing

Domain Partitioning

Parallel

CFD Solver Input Mesh i

Mesh i partitioned in

M parts

node-x node-x

node-x

node-z

./edgeCFDMesh mpirun –n 8

edgeCFDPre mpirun –n M

edgeCFD

16 Mesh i partitions

Solver executed

with 16 cores for

case i

Job i

Chiron is running in each core of each node:

managing scheduling, fault-tolerance, provenance

data gathering, … runtime provenance queries

CFDWorkflow

DisplayCluster

Prov-Vis

TiledWallDisplay

WorkflowEngine Provenance

Tags

[5]

WebClient

RemoteApplica on

Explora on1

Explora on2

Explora onN

...Explora on3

1 1 1

1 1

2

1

2

[5]Guerra,G.,Rochinha,F.,Elias,R.,etal.,2012,"UncertaintyQuan fica oninComputa onalPredic veModelsforFluidDynamicsUsingWorkflowManagementEngine",Interna onalJournalforUncertaintyQuan fica on,v.2,n.1.[6]Ocaña,K.A.C.S.,Oliveira,D.de,Horta,F.,etal.,2012,"ExploringMolecularEvolu onReconstruc onUsingaParallelCloud-basedScien ficWorkflow",AdvancesinBioinforma csandComputa onalBiology,chapter7409,Springer.[7]Ocaña,K.A.C.S.,Oliveira,D.,Ogasawara,E.,etal.,2011,"SciPhy:ACloud-BasedWorkflowforPhylogene cAnalysisofDrugTargetsinProtozoanGenomes",AdvancesinBioinforma csandComputa onalBiology,chapter6832Springer.[8]Ogasawara,E.,Dias,J.,Oliveira,D.,etal.,2011,"AnAlgebraicApproachforData-CentricScien ficWorkflows",Proc.ofVLDBEndowment,v.4,n.12.

[9]Oliveira,D.,Ogasawara,E.,Baião,F.,etal.,2010,"SciCumulus:ALightweightCloudMiddlewaretoExploreManyTaskCompu ngParadigminScien ficWorkflows”,IEEEInterna onalConferenceonCloudCompu ng,Washington,DC,USA.[10]Gadelha,L.M.R.,Clifford,B.,Ma oso,M.,etal.,2011,"ProvenancemanagementinSwi ",FutureGenera onComputerSystems,v.27,n.6(Jun.),DC,USA.[11]Deelman,E.,Mehta,G.,Singh,G.,etal.,2007,"Pegasus:MappingLarge-ScaleWorkflowstoDistributedResources",Workflowsfore-Science,Springer.[12]Fabian,N.,Moreland,K.,Thompson,D.,etal.,2011,"TheParaViewCoprocessingLibrary:Ascalable,generalpurposeinsituvisualiza onlibrary".[13]Valli,A.M.P.,Elias,R.N.,Carey,G.F.,etal.,2009,"PIDadap vecontrolofincrementalandarclengthcon nua oninnonlinearapplica ons",Interna onalJournalforNumericalMethodsinFluids,v.61,n.11(Dec.).

Page 61: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Distribution of Visualization Needs

Small problems: • Data are small and easily moved • Office machines and laptops are adequate

for visualization

* Sean Ahern/TACC courtesy

Medium problems: • Data are costly to move over WAN • Visualization requires lots of memory, fast

CPU and GPU

Large problems: • Data are impractical to move over WAN,

costly to move over LAN • Visualization requires parallel systems for

enough memory, CPU and GPU

Huge problems: • Data cannot be moved off system where it

is computed • Visualization requires equivalent resources

as source HPC system

Page 62: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Some Advices…

Huge problems Don’t move the data; in-situ and co-processing visualization minimizes or eliminates data I/O

Medium and small problems Move your data to visualization server and visualize using high-performance systems

Large problems Move your data to visualization server and visualize using parallel high-performance systems and software

Page 63: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Visualization @ NACAD

All simulations with EdgeCFD

Page 64: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

EXPLORING THE STOCHASTIC

SPACE

Uncertainty Propagation on Particle Laden Flows

Page 65: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Why currents move and deposit?

Investigation on how uncertainty in initial conditions and settling velocities propagate

Initial concentrations and settling velocities considered random fields

Simulations done with EdgeCFD1 with Stochastic Collocation Method

1G. M. Guerra, et al, Numerical simulation of particle-laden flows by the residual-based

variational multiscale method, IJNMF 73 (8) (2013) 729–749.

Page 66: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Computational Infrastructure

for Exploring the Stochastic Space

E. S. Ogasawara, et al: Chiron: a parallel engine for algebraic scientific workflows,

Concurrency and Computation: Practice and Experience 25 (16) (2013) 2327–2341.

Page 67: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Two-level Parallel Strategy

Page 68: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Computational Data

Level 6 Sparse Grid Stochastic

Collocation Method

1073 samples (each one a

parallel job) run on HPC

machine. Average run time for

each sample: 5h

108 jobs with 10 samples

managed with Chiron

Sequential time: 202 days

Two-level parallel run: 24 days

Page 69: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

What geologists want to know

3D representation of the deposition for both constituents at t=30: top and lateral views.

Colors on the surfaces correspond to the deposits thickness.

Page 70: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

What geologists want to know

Correlation map for the depositions

Page 71: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

CONCLUDING REMARKS AND

DISCUSSION

Page 72: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Multiphysics problems have been addressed

– Prospect of predicting the behavior of complex systems combining multiple physical phenomena

is one of the main motivations for extreme computing

– Scaling-up components is challenging. How to effectively combine them? How to generate,

manage and visualize data?

– Need of an integrated infrastructure

Advanced Algorithms and Solvers

– Smart algorithms (Inexact Newton, timestep control) really pays off

– Solvers are still challenging

Parallel Computations

– Communication issues of paramount importance

– Adaptivity introduces an extra complexity layer (needs repartition)

– Mesh generation still a problem

Visualization

– Try avoiding moving data around; Perspective of in-situ viz for large scale problems

Stochastic Multiphysics: New Frontier

– Managing the complexity of sampling stochastic space

– Issues: data management, fault tolerance, data provenance, etc

Page 73: Recent Advances in High Performance Computing for ...€¦ · Recent Advances in High Performance Computing for Multiphysics Problems Alvaro Coutinho alvaro@nacad.ufrj.br High Performance

Acknowledgements:

Faculty:

– HPC: A. Coutinho (PI), R.Elias

– Civil Engineering: J. Alves

– Mechanical Engineering: F. Rochinha

– Computer Science: M. Mattoso

Pos-Docs, Research Staff and Students:

– A. Aveleda, C. Barbosa, D. Barcarolo, O. Caldas, J. Camata, R.

Castaneda, A. Cortes, M. Costa, A. Cruz, J. Dias, I. Ghisi, M.

Goncalves Jr, J. Gonzalez, G. Guerra, N. Guevara Jr, F. Horta, E.

Lins, R. March, A. Mendonça, E. Ogasawara, D. Oliveira, A. Rossa,

F. Seabra, C. Silva, D. Vasconcelos, S. Zio

Funding: Petrobras, ANP, MCT/CNPq, MCT/FINEP, Petrobras

Computer Resources: NACAD/COPPE/UFRJ, TACC/UT Austin