A Parallel Hierarchical Solver for the Poisson Equation

Slides:



Advertisements
Similar presentations
School of something FACULTY OF OTHER School of Computing An Adaptive Numerical Method for Multi- Scale Problems Arising in Phase-field Modelling Peter.
Advertisements

1 Modal methods for 3D heterogeneous neutronics core calculations using the mixed dual solver MINOS. Application to complex geometries and parallel processing.
CSE 245: Computer Aided Circuit Simulation and Verification Matrix Computations: Iterative Methods (II) Chung-Kuan Cheng.
1 Iterative Solvers for Linear Systems of Equations Presented by: Kaveh Rahnema Supervisor: Dr. Stefan Zimmer
1 Numerical Solvers for BVPs By Dong Xu State Key Lab of CAD&CG, ZJU.
CS 290H 7 November Introduction to multigrid methods
SOLVING THE DISCRETE POISSON EQUATION USING MULTIGRID ROY SROR ELIRAN COHEN.
An Efficient Multigrid Solver for (Evolving) Poisson Systems on Meshes Misha Kazhdan Johns Hopkins University.
The Finite Element Method Defined
MECH593 Introduction to Finite Element Methods
By S Ziaei-Rad Mechanical Engineering Department, IUT.
Rayan Alsemmeri Amseena Mansoor. LINEAR SYSTEMS Jacobi method is used to solve linear systems of the form Ax=b, where A is the square and invertible.
1 A component mode synthesis method for 3D cell by cell calculation using the mixed dual finite element solver MINOS P. Guérin, A.M. Baudron, J.J. Lautard.
BVP Weak Formulation Weak Formulation ( variational formulation) where Multiply equation (1) by and then integrate over the domain Green’s theorem gives.
12/21/2001Numerical methods in continuum mechanics1 Continuum Mechanics On the scale of the object to be studied the density and other fluid properties.
Weak Formulation ( variational formulation)
MECH300H Introduction to Finite Element Methods
CS240A: Conjugate Gradients and the Model Problem.
Module on Computational Astrophysics Jim Stone Department of Astrophysical Sciences 125 Peyton Hall : ph :
Approximation of u
1 Parallel Simulations of Underground Flow in Porous and Fractured Media H. Mustapha 1,2, A. Beaudoin 1, J. Erhel 1 and J.R. De Dreuzy IRISA – INRIA.
Domain decomposition in parallel computing Ashok Srinivasan Florida State University COT 5410 – Spring 2004.
Parallel Adaptive Mesh Refinement Combined With Multigrid for a Poisson Equation CRTI RD Project Review Meeting Canadian Meteorological Centre August.
1 Numerical Integration of Partial Differential Equations (PDEs)
1 A Domain Decomposition Analysis of a Nonlinear Magnetostatic Problem with 100 Million Degrees of Freedom H.KANAYAMA *, M.Ogino *, S.Sugimoto ** and J.Zhao.
Estimating the Laplace-Beltrami Operator by Restricting 3D Functions Ming Chuang 1, Linjie Luo 2, Benedict Brown 3, Szymon Rusinkiewicz 2, and Misha Kazhdan.
Hans De Sterck Department of Applied Mathematics University of Colorado at Boulder Ulrike Meier Yang Center for Applied Scientific Computing Lawrence Livermore.
Distributed Multigrid for Processing Huge Spherical Images Michael Kazhdan Johns Hopkins University.
CFD Lab - Department of Engineering - University of Liverpool Ken Badcock & Mark Woodgate Department of Engineering University of Liverpool Liverpool L69.
1 Spring 2003 Prof. Tim Warburton MA557/MA578/CS557 Lecture 31.
1 Variational and Weighted Residual Methods. 2 The Weighted Residual Method The governing equation for 1-D heat conduction A solution to this equation.
The Finite Element Method A Practical Course
Parallel Solution of the Poisson Problem Using MPI
CS240A: Conjugate Gradients and the Model Problem.
HEAT TRANSFER FINITE ELEMENT FORMULATION
A Dirichlet-to-Neumann (DtN)Multigrid Algorithm for Locally Conservative Methods Sandia National Laboratories is a multi program laboratory managed and.
Introduction to Scientific Computing II Multigrid Dr. Miriam Mehl.
Lecture 21 MA471 Fall 03. Recall Jacobi Smoothing We recall that the relaxed Jacobi scheme: Smooths out the highest frequency modes fastest.
CHAP 3 WEIGHTED RESIDUAL AND ENERGY METHOD FOR 1D PROBLEMS
Discretization Methods Chapter 2. Training Manual May 15, 2001 Inventory # Discretization Methods Topics Equations and The Goal Brief overview.
Discretization for PDEs Chunfang Chen,Danny Thorne Adam Zornes, Deng Li CS 521 Feb., 9,2006.
Chapter 7 Finite element programming May 17, 2011.
Partial Derivatives Example: Find If solution: Partial Derivatives Example: Find If solution: gradient grad(u) = gradient.
Consider Preconditioning – Basic Principles Basic Idea: is to use Krylov subspace method (CG, GMRES, MINRES …) on a modified system such as The matrix.
A Parallel Hierarchical Solver for the Poisson Equation Seung Lee Deparment of Mechanical Engineering
Programming assignment # 3 Numerical Methods for PDEs Spring 2007 Jim E. Jones.
Multipole-Based Preconditioners for Sparse Linear Systems. Ananth Grama Purdue University. Supported by the National Science Foundation.
ANSYS, Inc. Proprietary © 2004 ANSYS, Inc. Chapter 5 Distributed Memory Parallel Computing v9.0.
X1X1 X2X2  Basic Kinematics Real Applications Simple Shear Trivial geometry Proscribed homogenous deformations Linear constitutive.
Fast 3D Least-squares Migration with a Deblurring Filter Wei Dai.
Monte Carlo Linear Algebra Techniques and Their Parallelization Ashok Srinivasan Computer Science Florida State University
High Performance Computing Seminar II Parallel mesh partitioning with ParMETIS Parallel iterative solvers with Hypre M.Sc. Caroline Mendonça Costa.
1 CHAP 3 WEIGHTED RESIDUAL AND ENERGY METHOD FOR 1D PROBLEMS FINITE ELEMENT ANALYSIS AND DESIGN Nam-Ho Kim.
Two-Dimensional Phase Unwrapping On FPGAs And GPUs
Xing Cai University of Oslo
Boundary Element Method
Introduction to the Finite Element Method
Model Problem: Solving Poisson’s equation for temperature
A computational loop k k Integration Newton Iteration
Solving Poisson Equations Using Least Square Technique in Image Editing Colin Zheng Yi Li.
MultiGrid.
Finite Element Method To be added later 9/18/2018 ELEN 689.
GPU Implementations for Finite Element Methods
Supported by the National Science Foundation.
One dimensional Poisson equation
Final Review.
Numerical Linear Algebra
Parallel build blocks.
Introduction to Scientific Computing II
A computational loop k k Integration Newton Iteration
Presentation transcript:

A Parallel Hierarchical Solver for the Poisson Equation Seung Lee selee@mit.edu R.Sudarshan darshan@mit.edu 18th March 2003

Outline Introduction Single level vs. multilevel approaches Preconditioning and adaptivity Galerkin formulation Solution of equations Scope for parallelization Implementation issues Road Map/Conclusions

Introduction Problem being considered: Discretize using piecewise bilinear hierarchical bases Approximate solution as

Single Level Vs. Multilevel Approaches +  + 

(Galerkin) Weak Form Formally, Leads to a multilevel system of equations Coarse <=> coarse interactions Coarse <=> fine interactions Fine <=> fine interactions

Solution of Equations K is not banded (but sparse nonetheless) Entries decay away from the diagonal Solve system using preconditioned conjugate gradient method with diagonal preconditioning Hierarchical solution also possible (solve coarsest level, next finer level, next finer level, …. ala multigrid)

How to Parallelize This Problem? Hierarchical domain decomposition Assembly of the stiffness matrix (almost embarrassingly parallel) Need to account for boundary vertices (shown as ) Some message passing involved Imposing Dirichlet boundary conditions Parallel conjugate gradient Probably use a canned solver?

Implementation Issues Parallel assembly Allocating geometry/level information among procs Need a suitable sparse matrix data structure PCG Solver Need to be able to compute A x for sparse A (BLAS?) Computing the ||Residue|| needs some communication Synthesis of the final solution vector Can be done in parallel Results can be bumped up to the root node to be consolidated

Parallel distribution of data Solve using PCG solver Road Map / Conclusions Identify the problems Parallel distribution of data Solve using PCG solver Retrieve the final solution