Discrete Ordinates Method (SN)

Slides:



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

Ionization of the Hydrogen Molecular Ion by Ultrashort Intense Elliptically Polarized Laser Radiation Ryan DuToit Xiaoxu Guan (Mentor) Klaus Bartschat.
The Finite Element Method Defined
ME 595M J.Murthy1 ME 595M: Computational Methods for Nanoscale Thermal Transport Lecture 9: Introduction to the Finite Volume Method for the Gray BTE J.
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.
Thermal Radiation Solver
Iterative Solvers for Coupled Fluid-Solid Scattering Jan Mandel Work presentation Center for Aerospace Structures University of Colorado at Boulder October.
Electron Beams: Dose calculation algorithms Kent A. Gifford, Ph.D. Department of Radiation Physics UT M.D. Anderson Cancer Center
ME 595M J.Murthy1 ME 595M: Computational Methods for Nanoscale Thermal Transport Lecture 9: Boundary Conditions, BTE Code J. Murthy Purdue University.
Module on Computational Astrophysics Jim Stone Department of Astrophysical Sciences 125 Peyton Hall : ph :
ME 595M J.Murthy1 ME 595M: Computational Methods for Nanoscale Thermal Transport Lecture 11: Homework solution Improved numerical techniques J. Murthy.
Monte Carlo Methods in Partial Differential Equations.
Heat Transfer Modeling
Exercise problems for students taking the Programming Parallel Computers course. Janusz Kowalik Piotr Arlukowicz Tadeusz Puzniakowski Informatics Institute.
Systems of Linear Equations Iterative Methods
Solving Scalar Linear Systems Iterative approach Lecture 15 MA/CS 471 Fall 2003.
An Effective Dynamic Scheduling Runtime and Tuning System for Heterogeneous Multi and Many-Core Desktop Platforms Authous: Al’ecio P. D. Binotto, Carlos.
Particle Transport Methods in Parallel Environments
S.S. Yang and J.K. Lee FEMLAB and its applications POSTEC H Plasma Application Modeling Lab. Oct. 25, 2005.
PuReMD: Purdue Reactive Molecular Dynamics Package Hasan Metin Aktulga and Ananth Grama Purdue University TST Meeting,May 13-14, 2010.
02/16/05© 2005 University of Wisconsin Last Time Re-using paths –Irradiance Caching –Photon Mapping.
CFD Lab - Department of Engineering - University of Liverpool Ken Badcock & Mark Woodgate Department of Engineering University of Liverpool Liverpool L69.
Parallel MDOM for Rendering Participating Media Ajit Hakke Patil – Daniele Bernabei Charly Collin – Ke Chen – Sumanta Pattanaik Fabio Ganovelli.
The Perfectly Matched Layer (PML)
Computational Aspects of Multi-scale Modeling Ahmed Sameh, Ananth Grama Computing Research Institute Purdue University.
Lesson 4: Computer method overview
Manno, , © by Supercomputing Systems 1 1 COSMO - Dynamical Core Rewrite Approach, Rewrite and Status Tobias Gysi POMPA Workshop, Manno,
Parallel Solution of the Poisson Problem Using MPI
Green's function solution to subsurface light transport for BRDF computation Charly Collin – Ke Chen – Ajit Hakke-Patil Sumanta Pattanaik – Kadi Bouatouch.
Lecture 21 MA471 Fall 03. Recall Jacobi Smoothing We recall that the relaxed Jacobi scheme: Smooths out the highest frequency modes fastest.
Parallel Adaptive Mesh Refinement for Radiation Transport and Diffusion Louis Howell Center for Applied Scientific Computing/ AX Division Lawrence Livermore.
10-1 Lesson 10 Objectives Chapter 4 [1,2,3,6]: Multidimensional discrete ordinates Chapter 4 [1,2,3,6]: Multidimensional discrete ordinates Multidimensional.
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.
Monte Carlo Linear Algebra Techniques and Their Parallelization Ashok Srinivasan Computer Science Florida State University
Programming assignment # 3 Numerical Methods for PDEs Spring 2007 Jim E. Jones.
(A) Future of Radiation Parameterizations in CAM Bill Collins National Center for Atmospheric Research
Department of Computer Science, Johns Hopkins University Lecture 7 Finding Concurrency EN /420 Instructor: Randal Burns 26 February 2014.
Application of Design Patterns to Geometric Decompositions V. Balaji, Thomas L. Clune, Robert W. Numrich and Brice T. Womack.
 155 South 1452 East Room 380  Salt Lake City, Utah  This research was sponsored by the National Nuclear Security Administration.
EEE 431 Computational Methods in Electrodynamics
Two-Dimensional Phase Unwrapping On FPGAs And GPUs
Parallel Plasma Equilibrium Reconstruction Using GPU
Spatial treatment in 1D Slab Discrete Ordinates
Chapter 4 [1,2,3,6]: Multidimensional discrete ordinates
Solving Linear Systems Ax=b
J. Murthy Purdue University
ივანე ჯავახიშვილის სახელობის
Nodal Methods for Core Neutron Diffusion Calculations
Propagating the Time Dependent Schroedinger Equation
Appendix C Radiation Modeling
Lecture 19 MA471 Fall 2003.
Clustering (3) Center-based algorithms Fuzzy k-means
L21: Putting it together: Tree Search (Ch. 6)
Resource Utilization in Large Scale InfiniBand Jobs
Convergence in Computational Science
The Rendering Equation
Simulation at NASA for the Space Radiation Effort
AIAA OBSERVATIONS ON CFD SIMULATION UNCERTAINITIES
AIAA OBSERVATIONS ON CFD SIMULATION UNCERTAINTIES
Supported by the National Science Foundation.
Parallelization of Sparse Coding & Dictionary Learning
COMP60621 Designing for Parallelism
PHYS 408 Applied Optics (Lecture 6)
OPTICS III, IV: Global Illumination
The Transport Equation
Ph.D. Thesis Numerical Solution of PDEs and Their Object-oriented Parallel Implementations Xing Cai October 26, 1998.
Lesson 4: Application to transport distributions
CASA Day 9 May, 2006.
Presentation transcript:

Discrete Ordinates Method (SN) Ari Frankel

Overview Current implementation (Soleil-MPI) MATLAB sample code Particle homogenization Intensity Sweeps Iterative solver Special PSAAP requirements MATLAB sample code Parallelization methods

Radiation Solver: Why Bother? Optically thin is very easy… But misses what happens when particle loading is increased, more complex physics Particles “shadow” each other, scattering, etc. Extensions to other problems Radiation hydrodynamics Neutron/electron transport These applications are far more expensive than any fluid dynamics problem Challenging due to all-to-all data dependence

The RTE Here it is: Intensity depends on 3 spatial variables and 2 angular variables (θ,φ) dΩ (x,y,z)

Particle homogenization Coefficients determined by scalar particle concentration/size Current choice: box counting

Discrete Ordinates Method Discretize angular domain on unit sphere with point collocation Tabulated quadrature sets read in to code, weights and angles (si,wi) Data: I(angle)(x,y,z) 350 angles total in this set

Discrete ordinates method Now: system of coupled first-order PDEs Could discretize in space, put in to matrix solver… But bandwidth/size of system is huge Standard method: iterate on summation

Source iteration Iterative method: Decoupled system of IVPs For our problems, typically takes less than 10 iterations to converge

Iib+1/2 Iia-1/2 Iia,b,c Iia+1/2 Iib-1/2

Sweeps These problems can be solved directly Finite difference/volume on structured grid, index (a,b,c):

Sweeps Auxiliary relation, choose γ=1/2

Sweeps The sweep: For a given angle, determine sweeping direction and starting cell (corner, in Cartesian grid) For each sequential cell: Compute cell-centered intensity from entering intensities Compute outgoing intensities Depending on direction, incoming and outgoing indices change

Step 1: integration Solving for: Assumed known: Known:

Step 2: extrapolation Solving for: Known:

Iteration The solver: Guaranteed to converge! Make initial guess for intensity While not converged: Compute source function for each cell Sweep all directions to compute new intensity Determine residual, update guess Guaranteed to converge! Diagonally dominant, bounded spectral radius independent of grid size and quadrature When done, can compute heat transfer for a particle from intensity field

Special PSAAP Reqs. Quadrature size: ~350 in cases so far, anticipate needing more in extrapolatory case Different grids! Radiation spatial grid can be coarser than fluid grid Boundary conditions! Lasers are highly collimated/focused Assuming perfectly aligned along perpendicular axis of channel Quadrature sets I’m using have an angle on y-axis, just set initial y-angle value to Io Solution frequency! Kinda expensive; solve once per time step currently

Code Walkthrough MATLAB, 2D DOM solver Will make code available to anybody who wants it Will write a Python version if needed

Parallelization Parallel sweeps Sweeps are inherently serial process Angles are independent in single iteration “Pipeline” the angles asynchronously Wavefront algorithm Non-blocking receive from upstream proc Sweep sub-domain Non-blocking send to downstream proc

Parallel Sweeps The CPU layout Subdomain Sweep 12 angles

Parallel Sweeps 3 4 1 2

Parallel Sweeps 7 3 4 8 1 2 5 6

Parallel Sweeps 11 7 3 4 8 12 1 2 5 6 9 10

Parallel Sweeps 11 7 3 4 8 12 1 2 5 6 9 10 Imminent collisions!

Parallel Sweeps Domain decomposition matters! Collisions Volumetric versus long columns can impact scalability Lab people prefer long column But we have a CFD code that prefers volumetric Collisions If/when CPU ends up with multiple angles at the same time, what to do? Decide on priority Idling is possible if number of angles is very small Yet: I got about 30% strong scaling efficiency from 1->4096 CPUs on Mustang (LANL) Texas A&M had about 70% weak scaling on Jaguar (ORNL) (1M CPUs)

Strong Scaling, Mustang (LANL)  200x200x200 grid 350 angles ~10 sweeps

SNAP (LANL) SN Application Proxy Solves similar problem in similar way Fancier features: Vectorized sweeps (sweep multiple angles at the same time) Different domain decompositions Hybrid architectures Solves slightly more complex problem

Conclusions DOM is a big problem Iterative solver has nice convergence properties Sweeps are bottleneck Scaling is a challenge

Alternatives to parallel sweeps There are no alternatives (But actually, here are some alternatives): Matrix solvers (HYPRE/PetSc/Trilinos… ) Pros: Straightforward, black box solver Cons: Expensive, not studied extensively, convergence may be difficult, requires interfacing with outside libraries Inexact Parallel Block-Jacobi Pros: Only local sweeps, highly scalable Cons: VERY slow convergence for our cases Pseudo-time stepping Pros: Straightforward, scalable Cons: VERY slow convergence, will require more communications

Alternatives to DOM Outside of DOM: Method of characteristics Similar to DOM, but requires tracing along lines through domain Likely more expensive Monte Carlo Ray Tracing May utilize particle-based infrastructure, each ray is independent Parallelization: by ray, by domain decomp., or mixed Most expensive option, variance decreases as 1/N Spherical harmonic expansions System of coupled elliptic PDEs in space Also expensive to formulate and solve in matrix Diffusion- lowest order spherical harmonic expansion Helmholtz equation Not a convergent/accurate solution, requires smoothing/regularization of particles