Marching Solver for Poisson Equation 大氣四 簡睦樺. Outline A brief review for Poisson equation and marching method Parallel algorithm and consideration for.

Slides:



Advertisements
Similar presentations
Courant and all that Consistency, Convergence Stability Numerical Dispersion Computational grids and numerical anisotropy The goal of this lecture is to.
Advertisements

Partial Differential Equations
Parallel Jacobi Algorithm Steven Dong Applied Mathematics.
Chapter 8 Elliptic Equation.
Algebraic, transcendental (i.e., involving trigonometric and exponential functions), ordinary differential equations, or partial differential equations...
Point-wise Discretization Errors in Boundary Element Method for Elasticity Problem Bart F. Zalewski Case Western Reserve University Robert L. Mullen Case.
B.Macukow 1 Lecture 12 Neural Networks. B.Macukow 2 Neural Networks for Matrix Algebra Problems.
MATH 685/ CSI 700/ OR 682 Lecture Notes
Linear Systems of Equations
Error Measurement and Iterative Methods
Solution of linear system of equations
1 EE 616 Computer Aided Analysis of Electronic Networks Lecture 3 Instructor: Dr. J. A. Starzyk, Professor School of EECS Ohio University Athens, OH,
CS 584. Review n Systems of equations and finite element methods are related.
ECIV 301 Programming & Graphics Numerical Methods for Engineers Lecture 20 Solution of Linear System of Equations - Iterative Methods.
Special Matrices and Gauss-Siedel
NAE C_S2001 FINAL PROJECT PRESENTATION LASIC ISMAR 04/12/01 INSTRUCTOR: PROF. GUTIERREZ.
ECIV 301 Programming & Graphics Numerical Methods for Engineers REVIEW II.
Monica Garika Chandana Guduru. METHODS TO SOLVE LINEAR SYSTEMS Direct methods Gaussian elimination method LU method for factorization Simplex method of.
1 Chapter 9 NUMERICAL SOLUTION OF PARTIAL DIFFERENTIAL EQUATIONS.
Newton's Method for Functions of Several Variables
Partial differential equations Function depends on two or more independent variables This is a very simple one - there are many more complicated ones.
SOLUTION FOR THE BOUNDARY LAYER ON A FLAT PLATE
Secant Method Another Recursive Method. Secant Method The secant method is a recursive method used to find the solution to an equation like Newton’s Method.
Numerical Methods Due to the increasing complexities encountered in the development of modern technology, analytical solutions usually are not available.
Time integration methods for the Heat Equation Solution u for t= Tobias Köppl TUM.
Copyright © 2006 The McGraw-Hill Companies, Inc. Permission required for reproduction or display. by Lale Yurttas, Texas A&M University Part 31 Linear.
Advanced Computer Graphics Spring 2014 K. H. Ko School of Mechatronics Gwangju Institute of Science and Technology.
Solving Scalar Linear Systems Iterative approach Lecture 15 MA/CS 471 Fall 2003.
Newton's Method for Functions of Several Variables Joe Castle & Megan Grywalski.
Scientific Computing Partial Differential Equations Poisson Equation.
Scientific Computing Partial Differential Equations Implicit Solution of Heat Equation.
Efficient Integration of Large Stiff Systems of ODEs Using Exponential Integrators M. Tokman, M. Tokman, University of California, Merced 2 hrs 1.5 hrs.
Final Project Solution to a Hyperbolic problem using Mimetic Methods Caplan,Ron Jimenez, Rosa Martinez, Joan M. M 542 Intro. to Numerical Solutions to.
Elliptic PDEs and the Finite Difference Method
Introduction Examples of differential equations and related problems Analytical versus numerical solutions Ideas of numerical representations of solutions.
Boundary Value Problems l Up to this point we have solved differential equations that have all of their initial conditions specified. l There is another.
Numerical Methods.
Parallel and Domain Decomposed Marching Method for Poisson Equation 大氣五 b 簡睦樺.
Dr. Jie Zou PHY Chapter 2 Solution of Nonlinear Equations: Lecture (II)
Introduction to Scientific Computing II Overview Michael Bader.
Darryl Michael/GE CRD Fields and Waves Lesson 3.6 ELECTROSTATICS - Numerical Simulation.
Lecture 21 MA471 Fall 03. Recall Jacobi Smoothing We recall that the relaxed Jacobi scheme: Smooths out the highest frequency modes fastest.
MULTISCALE COMPUTATIONAL METHODS Achi Brandt The Weizmann Institute of Science UCLA
Elliptic PDEs and Solvers
Chapter 7 Finite element programming May 17, 2011.
MULTIDIMENSIONAL HEAT TRANSFER  This equation governs the Cartesian, temperature distribution for a three-dimensional unsteady, heat transfer problem.
Finding Grid Point Neighbors Matt Craven for: Dr. Anitescu Math 1110 Spring 2002.
Linear Systems Numerical Methods. 2 Jacobi Iterative Method Choose an initial guess (i.e. all zeros) and Iterate until the equality is satisfied. No guarantee.
Programming assignment # 3 Numerical Methods for PDEs Spring 2007 Jim E. Jones.
Relaxation Methods in the Solution of Partial Differential Equations
EEE 431 Computational Methods in Electrodynamics
Xing Cai University of Oslo
Introduction Numerical model
Partial Differential Equations and Applied Mathematics Seminar
Solving Linear Systems Ax=b
Scientific Computing Lab
FEM : Finite Element Method 2017.
Lecture 19 MA471 Fall 2003.
CHAPTER OBJECTIVES The primary objective of this chapter is to show how to compute the matrix inverse and to illustrate how it can be.
Numerical Solutions of Partial Differential Equations
Scientific Computing Partial Differential Equations Implicit Solution of Heat Equation.
One dimensional Poisson equation
Numerical Analysis Lecture13.
6.5 Taylor Series Linearization
Numerical Linear Algebra
Introduction to Scientific Computing II
Numerical Computation and Optimization
Programming assignment #1 Solving an elliptic PDE using finite differences Numerical Methods for PDEs Spring 2007 Jim E. Jones.
Home assignment #3 (1) (Total 3 problems) Due: 12 November 2018
Ax = b Methods for Solution of the System of Equations (ReCap):
Presentation transcript:

Marching Solver for Poisson Equation 大氣四 簡睦樺

Outline A brief review for Poisson equation and marching method Parallel algorithm and consideration for efficiency Results Future works

Poisson Equation A second order partial differential equation with inhomogeneous forcing term is called Poisson equation. i.e. Ω is the domain, L is some operator for boundary condition.

Numerical approximation Let U ij =u(x,y), approximate the equation with finite difference method. For marching method

Marching method Let, where U i,j is the exact solution, U’ i,j is guess solution, e i,j is the difference between U i,j and U’ i,j. ij=0…n+1(U i,0, U 0,j, U i,n+1 and U n+1,j are boundary) We have a initial guess for U’ i,1 and compute U’ i,2 via marching equation.

Let a vector of equation of e, i.e. E 1,1 =[ ] T and E 2,1 =[ ] T and compute the equation of e. Thus, we can construct and system of e in+1 and U’ in+1 –U in+1. i.e. We solve the system and get e i,1, so we can get U i,1

Domain decomposition idea However, the above method may fail easily because the condition number of the system may be to huge. To construct error vector from E i,1, E n+1,1 and other interior point. we can have the local equation for some marching points for which different initial condition march and should have same value.

Parallel Algorithm Use MPI to compute the decomposed domain. Separate the computation into preprocessor and marching.

Preprocessor To compute inverse matrix of the system preprocessor Compute error vector Parallel LU Out put Compute error vector Parallel LU Out put

Marching marching Read data marching Read data marching

Collect error vector Matrix product

Connect Boundary data Marching again to get exact sol.

Operation count For general case, define nx for grid points at x-direction, ny for grid points at y direction, nb is number of sub-domain ~ nx/5. For serial case, preprocessor: Error vector: O(ny*ny*nx) LU: O((ny*nb) 3 ) marching: marching: O(ny*nx) matrix product: O((ny*nb) 2 )

Parallel case ng is number of MPI world. nb>=ng preprocessor: Error vector: O(ny*ny*nx/ng) LU: O((ny*nb) 3 ) marching: marching: O(ny*nx/ng) matrix product: O((ny*nb/ng) 2 )

Compare with other method SerialMarchLUIteration +prep Iteration Prep(ny*nb) 3 (ny*nx) 3 0 march(ny*nb) 2 (ny*nx) 2 (ny*nx) 3 1 time problem (ny*nb) 3 (ny*nx) 3

results Converge error Efficiency improvement Annulus testing case

Converge error Testing case

Error table HErrorRatioorder e-5NaN e e e

Log-log plot

Efficiency For 128*128 case NPTime

Annulus

Future work Parallel LU 3D marching method