02/09/2005CS267 Lecture 71 CS 267 Sources of Parallelism and Locality in Simulation – Part 2 James Demmel www.cs.berkeley.edu/~demmel/cs267_Spr05.

Slides:



Advertisements
Similar presentations
Parallel Jacobi Algorithm Steven Dong Applied Mathematics.
Advertisements

A NOVEL APPROACH TO SOLVING LARGE-SCALE LINEAR SYSTEMS Ken Habgood, Itamar Arel Department of Electrical Engineering & Computer Science GABRIEL CRAMER.
Chapter 8 Elliptic Equation.
03/23/07CS267 Lecture 201 CS 267: Multigrid on Structured Grids Kathy Yelick
SOLVING THE DISCRETE POISSON EQUATION USING MULTIGRID ROY SROR ELIRAN COHEN.
Parallelizing stencil computations Based on slides from David Culler, Jim Demmel, Bob Lucas, Horst Simon, Kathy Yelick, et al., UCB CS267.
SOLVING SYSTEMS OF LINEAR EQUATIONS. Overview A matrix consists of a rectangular array of elements represented by a single symbol (example: [A]). An individual.
Numerical Algorithms Matrix multiplication
1cs542g-term Notes  Assignment 1 will be out later today (look on the web)
Total Recall Math, Part 2 Ordinary diff. equations First order ODE, one boundary/initial condition: Second order ODE.
Linear Algebraic Equations
CS 584. Review n Systems of equations and finite element methods are related.
03/09/2005CS267 Lecture 14 CS 267: Applications of Parallel Computers Solving Linear Systems arising from PDEs - I James Demmel
ECE669 L4: Parallel Applications February 10, 2004 ECE 669 Parallel Computer Architecture Lecture 4 Parallel Applications.
CS267 Poisson Demmel Fall 2002 CS 267 Applications of Parallel Computers Solving Linear Systems arising from PDEs - I James Demmel
Sparse Matrix Algorithms CS 524 – High-Performance Computing.
CS267 L12 Sources of Parallelism(3).1 Demmel Sp 1999 CS 267 Applications of Parallel Computers Lecture 12: Sources of Parallelism and Locality (Part 3)
CS267 L24 Solving PDEs.1 Demmel Sp 1999 CS 267 Applications of Parallel Computers Lecture 24: Solving Linear Systems arising from PDEs - I James Demmel.
CS267 Poisson 2.1 Demmel Fall 2002 CS 267 Applications of Parallel Computers Solving Linear Systems arising from PDEs - II James Demmel
Avoiding Communication in Sparse Iterative Solvers Erin Carson Nick Knight CS294, Fall 2011.
CS267 L12 Sources of Parallelism(3).1 Demmel Sp 1999 CS 267 Applications of Parallel Computers Lecture 12: Sources of Parallelism and Locality (Part 3)
3/1/2004CS267 Lecure 101 CS 267 Sources of Parallelism Kathy Yelick
03/09/06CS267 Lecture 16 CS 267: Applications of Parallel Computers Solving Linear Systems arising from PDEs - II James Demmel
High Performance Computing 1 Parallelization Strategies and Load Balancing Some material borrowed from lectures of J. Demmel, UC Berkeley.
CS267 L24 Solving PDEs.1 Demmel Sp 1999 CS 267 Applications of Parallel Computers Lecture 24: Solving Linear Systems arising from PDEs - I James Demmel.
CS267 L11 Sources of Parallelism(2).1 Demmel Sp 1999 CS 267 Applications of Parallel Computers Lecture 11: Sources of Parallelism and Locality (Part 2)
CS267 L25 Solving PDEs II.1 Demmel Sp 1999 CS 267 Applications of Parallel Computers Lecture 25: Solving Linear Systems arising from PDEs - II James Demmel.
CS240A: Conjugate Gradients and the Model Problem.
CS267 L24 Solving PDEs.1 Demmel Sp 1999 CS 267 Applications of Parallel Computers Lecture 24: Solving Linear Systems arising from PDEs - I James Demmel.
02/14/2007CS267 Lecture 91 CS 267 Sources of Parallelism and Locality in Simulation Kathy Yelick
PDEs & Parabolic problems Jacob Y. Kazakia © Partial Differential Equations Linear in two variables: Usual classification at a given point (x,y):
Monica Garika Chandana Guduru. METHODS TO SOLVE LINEAR SYSTEMS Direct methods Gaussian elimination method LU method for factorization Simplex method of.
1 Sources of Parallelism and Locality in Simulation.
Chapter 13 Finite Difference Methods: Outline Solving ordinary and partial differential equations Finite difference methods (FDM) vs Finite Element Methods.
Module on Computational Astrophysics Jim Stone Department of Astrophysical Sciences 125 Peyton Hall : ph :
SE301: Numerical Methods Topic 9 Partial Differential Equations (PDEs) Lectures KFUPM Read & CISE301_Topic9 KFUPM.
Conjugate gradients, sparse matrix-vector multiplication, graphs, and meshes Thanks to Aydin Buluc, Umit Catalyurek, Alan Edelman, and Kathy Yelick for.
Exercise problems for students taking the Programming Parallel Computers course. Janusz Kowalik Piotr Arlukowicz Tadeusz Puzniakowski Informatics Institute.
Global Address Space Applications Kathy Yelick NERSC/LBNL and U.C. Berkeley.
02/14/2007CS267 Lecture 91 CS 267 Sources of Parallelism and Locality in Simulation – Part 2 Kathy Yelick
Scientific Computing Partial Differential Equations Poisson Equation.
Copyright © The McGraw-Hill Companies, Inc. Permission required for reproduction or display. Parallel Programming in C with MPI and OpenMP Michael J. Quinn.
Computation on meshes, sparse matrices, and graphs Some slides are from David Culler, Jim Demmel, Bob Lucas, Horst Simon, Kathy Yelick, et al., UCB CS267.
Discontinuous Galerkin Methods and Strand Mesh Generation
Linear Systems Iterative Solutions CSE 541 Roger Crawfis.
Parallel Simulation of Continuous Systems: A Brief Introduction
Discontinuous Galerkin Methods for Solving Euler Equations Andrey Andreyev Advisor: James Baeder Mid.
Elliptic PDEs and the Finite Difference Method
02/07/2006CS267 Lecture 71 CS 267 Sources of Parallelism and Locality in Simulation – Part 2 James Demmel
1 CS240A: Parallelism in CSE Applications Tao Yang Slides revised from James Demmel and Kathy Yelick
CS 267 Sources of Parallelism and Locality in Simulation – Part 2
Akram Bitar and Larry Manevitz Department of Computer Science
Forward modelling The key to waveform tomography is the calculation of Green’s functions (the point source responses) Wide range of modelling methods available.
Parallel Solution of the Poisson Problem Using MPI
CS240A: Conjugate Gradients and the Model Problem.
Introduction to Scientific Computing II Overview Michael Bader.
CS267 Lecture 41 CS 267 Sources of Parallelism and Locality in Simulation James Demmel and Kathy Yelick
C OMPUTATIONAL R ESEARCH D IVISION 1 Defining Software Requirements for Scientific Computing Phillip Colella Applied Numerical Algorithms Group Lawrence.
CS267 L24 Solving PDEs.1 Demmel Sp 1999 Math Poisson’s Equation, Jacobi, Gauss-Seidel, SOR, FFT Plamen Koev
Optimizing 3D Multigrid to Be Comparable to the FFT Michael Maire and Kaushik Datta Note: Several diagrams were taken from Kathy Yelick’s CS267 lectures.
Solving Linear Systems Ax=b
CS 267 Sources of Parallelism and Locality in Simulation – Part 2
Lecture 19 MA471 Fall 2003.
Computation on meshes, sparse matrices, and graphs
Computational meshes, matrices, conjugate gradients, and mesh partitioning Some slides are from David Culler, Jim Demmel, Bob Lucas, Horst Simon, Kathy.
CS 267 Sources of Parallelism and Locality in Simulation – Part 2
CS6068 Applications: Numerical Methods
CS 267 Sources of Parallelism and Locality in Simulation – Part 2
James Demmel CS 267 Applications of Parallel Computers Lecture 12: Sources of Parallelism and Locality.
Comparison of CFEM and DG methods
Presentation transcript:

02/09/2005CS267 Lecture 71 CS 267 Sources of Parallelism and Locality in Simulation – Part 2 James Demmel

02/09/05CS267 Lecture 72 Recap of Last Lecture 4 kinds of simulations Discrete Event Systems Particle Systems Ordinary Differential Equations (ODEs) Today: Partial Differential Equations (PDEs) Common problems: Load balancing Dynamically, if load changes significantly during run Statically – Graph Partitioning –Sparse Matrix Vector Multiply (SpMV) Linear Algebra Solving linear systems of equations, eigenvalue problems Sparse and dense matrices Fast Particle Methods Solving in O(n) instead of O(n 2 )

02/09/2005CS267 Lecture 73 Partial Differential Equations PDEs

02/09/05CS267 Lecture 74 Continuous Variables, Continuous Parameters Examples of such systems include Elliptic problems (steady state, global space dependence) Electrostatic or Gravitational Potential: Potential(position) Hyperbolic problems (time dependent, local space dependence): Sound waves: Pressure(position,time) Parabolic problems (time dependent, global space dependence) Heat flow: Temperature(position, time) Diffusion: Concentration(position, time) Many problems combine features of above Fluid flow: Velocity,Pressure,Density(position,time) Elasticity: Stress,Strain(position,time)

02/09/05CS267 Lecture 75 Example: Deriving the Heat Equation 01 x x+h Consider a simple problem A bar of uniform material, insulated except at ends Let u(x,t) be the temperature at position x at time t Heat travels from x-h to x+h at rate proportional to: As h  0, we get the heat equation: d u(x,t) (u(x-h,t)-u(x,t))/h - (u(x,t)- u(x+h,t))/h dt h = C * d u(x,t) d 2 u(x,t) dt dx 2 = C * x-h

02/09/05CS267 Lecture 76 Details of the Explicit Method for Heat Discretize time and space using explicit approach (forward Euler) to approximate time derivative: (u(x,t+  ) – u(x,t))/  = C (u(x-h,t) – 2*u(x,t) + u(x+h,t))/h 2 u(x,t+  ) = u(x,t)+ C*  /h 2 *(u(x-h,t) – 2*u(x,t) + u(x+h,t)) Let z = C*  /h 2 u(x,t+  ) = z* u(x-h,t) + (1-2z)*u(x,t) + z*u(x+h,t) Change variable x to j*h, t to i* , and u(x,t) to u[j,i] u[j,i+1]= z*u[j-1,i]+ (1-2*z)*u[j,i]+ z*u[j+1,i] d u(x,t) d 2 u(x,t) dt dx 2 = C *

02/09/05CS267 Lecture 77 Explicit Solution of the Heat Equation Use finite differences with u[j,i] as the temperature at time t= i*  (i = 0,1,2,…) and position x = j*h (j=0,1,…,N=1/h) initial conditions on u[j,0] boundary conditions on u[0,i] and u[N,i] At each timestep i = 0,1,2,... This corresponds to matrix vector multiply by T (next slide) Combine nearest neighbors on grid i=5 i=4 i=3 i=2 i=1 i=0 u[0,0] u[1,0] u[2,0] u[3,0] u[4,0] u[5,0] For j=0 to N u[j,i+1]= z*u[j-1,i]+ (1-2*z)*u[j,i] + z*u[j+1,i] where z =C*  /h 2 i j

02/09/05CS267 Lecture 78 Matrix View of Explicit Method for Heat u[j,i+1]= z*u[j-1,i]+ (1-2*z)*u[j,i] + z*u[j+1,i] u[ :, i+1] = T * u[ :, i] where T is tridiagonal: L called Laplacian (in 1D) For a 2D mesh (5 point stencil) the Laplacian is pentadiagonal More on the matrix/grid views later 1-2z z z Graph and “3 point stencil” T = = I – z*L, L = z z z 1-2z z z 1-2z

02/09/05CS267 Lecture 79 Parallelism in Explicit Method for PDEs Sparse matrix vector multiply, via Graph Partitioning Partitioning the space (x) into p largest chunks good load balance (assuming large number of points relative to p) minimized communication (only p chunks) Generalizes to multiple dimensions. arbitrary graphs (= arbitrary sparse matrices). Explicit approach often used for hyperbolic equations Problem with explicit approach for heat (parabolic): numerical instability. solution blows up eventually if z = C  /h 2 >.5 need to make the time steps very small when h is small:  <.5*h 2 /C

02/09/05CS267 Lecture 710 Instability in Solving the Heat Equation Explicitly

02/09/05CS267 Lecture 711 Implicit Solution of the Heat Equation Discretize time and space using implicit approach (backward Euler) to approximate time derivative: (u(x,t+  ) – u(x,t))/dt = C*(u(x-h,t+  ) – 2*u(x,t+  ) + u(x+h, t+  ))/h 2 u(x,t) = u(x,t+  )+ C*  /h 2 *(u(x-h,t+  ) – 2*u(x,t+  ) + u(x+h,t+  )) Let z = C*  /h 2 and change variable t to i* , x to j*h and u(x,t) to u[j,i] (I - z *L)* u[:, i+1] = u[:,i] Where I is identity and L is Laplacian as before L = d u(x,t) d 2 u(x,t) dt dx 2 = C *

02/09/05CS267 Lecture 712 Implicit Solution of the Heat Equation The previous slide used Backwards Euler, but using the trapezoidal rule gives better numerical properties (I - z *L)* u[:, i+1] = u[:,i] This turns into solving the following equation: Again I is the identity matrix and L is: Other problems yield Poisson’s equation (Lx = b in 1D) (I + (z/2)*L) * u[:,i+1]= (I - (z/2)*L) *u[:,i] L = 2 Graph and “stencil”

02/09/05CS267 Lecture 713 Relation of Poisson to Gravity, Electrostatics Poisson equation arises in many problems E.g., force on particle at (x,y,z) due to particle at 0 is -(x,y,z)/r 3, where r = sqrt(x 2 +y 2 +z 2 ) Force is also gradient of potential V = -1/r = -(d/dx V, d/dy V, d/dz V) = -grad V V satisfies Poisson’s equation (try working this out!) d 2 V + d 2 V + d 2 V = 0 dx 2 dy 2 dz 2

02/09/05CS267 Lecture 714 2D Implicit Method Similar to the 1D case, but the matrix L is now Multiplying by this matrix (as in the explicit case) is simply nearest neighbor computation on 2D grid. To solve this system, there are several techniques L = 4 Graph and “5 point stencil” 3D case is analogous (7 point stencil)

02/09/05CS267 Lecture 715 Algorithms for 2D (3D) Poisson Equation (N vars) AlgorithmSerialPRAMMemory #Procs Dense LUN 3 NN 2 N 2 Band LUN 2 (N 7/3 )NN 3/2 (N 5/3 )N JacobiN 2 NNN Explicit Inv.N log NNN Conj.GradientsN 3/2 N 1/2 *log NNN Red/Black SORN 3/2 N 1/2 NN Sparse LUN 3/2 (N 2 ) N 1/2 N*log N(N 4/3 ) N FFTN*log Nlog NNN MultigridNlog 2 NNN Lower boundNlog NN PRAM is an idealized parallel model with zero cost communication Reference: James Demmel, Applied Numerical Linear Algebra, SIAM,

02/09/05CS267 Lecture 716 Overview of Algorithms Sorted in two orders (roughly): from slowest to fastest on sequential machines. from most general (works on any matrix) to most specialized (works on matrices “like” T). Dense LU: Gaussian elimination; works on any N-by-N matrix. Band LU: Exploits the fact that T is nonzero only on sqrt(N) diagonals nearest main diagonal. Jacobi: Essentially does matrix-vector multiply by T in inner loop of iterative algorithm. Explicit Inverse: Assume we want to solve many systems with T, so we can precompute and store inv(T) “for free”, and just multiply by it (but still expensive). Conjugate Gradient: Uses matrix-vector multiplication, like Jacobi, but exploits mathematical properties of T that Jacobi does not. Red-Black SOR (successive over-relaxation): Variation of Jacobi that exploits yet different mathematical properties of T. Used in multigrid schemes. Sparse LU: Gaussian elimination exploiting particular zero structure of T. FFT (fast Fourier transform): Works only on matrices very like T. Multigrid: Also works on matrices like T, that come from elliptic PDEs. Lower Bound: Serial (time to print answer); parallel (time to combine N inputs). Details in class notes and

02/09/05CS267 Lecture 717 Mflop/s Versus Run Time in Practice Problem: Iterative solver for a convection-diffusion problem; run on a 1024-CPU NCUBE-2. Reference: Shadid and Tuminaro, SIAM Parallel Processing Conference, March SolverFlopsCPU Time(s)Mflop/s Jacobi3.82x Gauss-Seidel1.21x Multigrid2.13x Which solver would you select?

02/09/05CS267 Lecture 718 Summary of Approaches to Solving PDEs As with ODEs, either explicit or implicit approaches are possible Explicit, sparse matrix-vector multiplication Implicit, sparse matrix solve at each step Direct solvers are hard (more on this later) Iterative solves turn into sparse matrix-vector multiplication –Graph partitioning Grid and sparse matrix correspondence: Sparse matrix-vector multiplication is nearest neighbor “averaging” on the underlying mesh Not all nearest neighbor computations have the same efficiency Factors are the mesh structure (nonzero structure) and the number of Flops per point.

02/09/05CS267 Lecture 719 Comments on practical meshes Regular 1D, 2D, 3D meshes Important as building blocks for more complicated meshes Practical meshes are often irregular Composite meshes, consisting of multiple “bent” regular meshes joined at edges Unstructured meshes, with arbitrary mesh points and connectivities Adaptive meshes, which change resolution during solution process to put computational effort where needed

02/09/05CS267 Lecture 720 Parallelism in Regular meshes Computing a Stencil on a regular mesh need to communicate mesh points near boundary to neighboring processors. Often done with ghost regions Surface-to-volume ratio keeps communication down, but Still may be problematic in practice Implemented using “ghost” regions. Adds memory overhead

02/09/05CS267 Lecture 721 Composite mesh from a mechanical structure

02/09/05CS267 Lecture 722 Converting the mesh to a matrix

02/09/05CS267 Lecture 723 Effects of Ordering Rows and Columns on Gaussian Elimination

02/09/05CS267 Lecture 724 Irregular mesh: NASA Airfoil in 2D (direct solution)

02/09/05CS267 Lecture 725 Irregular mesh: Tapered Tube (multigrid)

02/09/05CS267 Lecture 726 Adaptive Mesh Refinement (AMR) Adaptive mesh around an explosion Refinement done by calculating errors Parallelism Mostly between “patches,” dealt to processors for load balance May exploit some within a patch (SMP) Projects: Titanium ( Chombo (P. Colella, LBL), KeLP (S. Baden, UCSD), J. Bell, LBL

02/09/05CS267 Lecture 727 Adaptive Mesh Shock waves in a gas dynamics using AMR (Adaptive Mesh Refinement) See: fluid density

02/09/05CS267 Lecture 728 Challenges of Irregular Meshes How to generate them in the first place Triangle, a 2D mesh partitioner by Jonathan Shewchuk 3D harder! How to partition them ParMetis, a parallel graph partitioner How to design iterative solvers PETSc, a Portable Extensible Toolkit for Scientific Computing Prometheus, a multigrid solver for finite element problems on irregular meshes How to design direct solvers SuperLU, parallel sparse Gaussian elimination These are challenges to do sequentially, more so in parallel

02/09/2005CS267 Lecture 729 Extra Slides

02/09/05CS267 Lecture 730 Composite Mesh from a Mechanical Structure

02/09/05CS267 Lecture 731 Converting the Mesh to a Matrix

02/09/05CS267 Lecture 732 Effects of Reordering on Gaussian Elimination

02/09/05CS267 Lecture 733 Irregular mesh: NASA Airfoil in 2D

02/09/05CS267 Lecture 734 Irregular mesh: Tapered Tube (Multigrid)

02/09/05CS267 Lecture 735 CS267 Final Projects Project proposal Teams of 3 students, typically across departments Interesting parallel application or system Conference-quality paper High performance is key: Understanding performance, tuning, scaling, etc. More important the difficulty of problem Leverage Projects in other classes (but discuss with me first) Research projects

02/09/05CS267 Lecture 736 Project Ideas Applications Implement existing sequential or shared memory program on distributed memory Investigate SMP trade-offs (using only MPI versus MPI and thread based parallelism) Tools and Systems Effects of reordering on sparse matrix factoring and solves Numerical algorithms Improved solver for immersed boundary method Use of multiple vectors (blocked algorithms) in iterative solvers

02/09/05CS267 Lecture 737 Project Ideas Novel computational platforms Exploiting hierarchy of SMP-clusters in benchmarks Computing aggregate operations on ad hoc networks (Culler) Push/explore limits of computing on “the grid” Performance under failures Detailed benchmarking and performance analysis, including identification of optimization opportunities Titanium UPC IBM SP (Blue Horizon)

02/09/05CS267 Lecture 738 Terminology Term hyperbolic, parabolic, elliptic, come from special cases of the general form of a second order linear PDE a*d 2 u/dx + b*d 2 u/dxdy + c*d 2 u/dy 2 + d*du/dx + e*du/dy + f = 0 where y is time Analog to solutions of general quadratic equation a*x 2 + b*xy + c*y 2 + d*x + e*y + f Backup slide: currently hidden.