ADI iterations for. general elliptic problems. John Strain Mathematics Department UC Berkeley July 2013

Similar documents
First-order overdetermined systems. for elliptic problems. John Strain Mathematics Department UC Berkeley July 2012

Moving interface problems. for elliptic systems. John Strain Mathematics Department UC Berkeley June 2010

Partial Differential Equations

Math 102, Winter Final Exam Review. Chapter 1. Matrices and Gaussian Elimination

Linear Algebra Massoud Malek

ADVANCED ENGINEERING MATHEMATICS MATLAB

EIGENVALUE PROBLEMS. Background on eigenvalues/ eigenvectors / decompositions. Perturbation analysis, condition numbers..

Linear Algebra Review. Vectors

INTRODUCTION TO PDEs

Eigenvalues in Applications

Math 302 Outcome Statements Winter 2013

Geometric Modeling Summer Semester 2010 Mathematical Tools (1)

M E M O R A N D U M. Faculty Senate approved November 1, 2018

Preliminary/Qualifying Exam in Numerical Analysis (Math 502a) Spring 2012

Solving PDEs with Multigrid Methods p.1

SPECTRAL PROPERTIES OF THE LAPLACIAN ON BOUNDED DOMAINS

Advanced. Engineering Mathematics

R. Courant and D. Hilbert METHODS OF MATHEMATICAL PHYSICS Volume II Partial Differential Equations by R. Courant

Practical Linear Algebra: A Geometry Toolbox

NUMERICAL COMPUTATION IN SCIENCE AND ENGINEERING

POLI270 - Linear Algebra

Cambridge University Press The Mathematics of Signal Processing Steven B. Damelin and Willard Miller Excerpt More information

Implicitly Defined High-Order Operator Splittings for Parabolic and Hyperbolic Variable-Coefficient PDE Using Modified Moments

Math Introduction to Numerical Analysis - Class Notes. Fernando Guevara Vasquez. Version Date: January 17, 2012.

METHODS FOR SOLVING MATHEMATICAL PHYSICS PROBLEMS

Kasetsart University Workshop. Multigrid methods: An introduction

CS 143 Linear Algebra Review

Cheng Soon Ong & Christian Walder. Canberra February June 2017

A THEORETICAL INTRODUCTION TO NUMERICAL ANALYSIS

Fast Iterative Solution of Saddle Point Problems

Numerical Methods in Matrix Computations

Partial Differential Equations and the Finite Element Method

BETI for acoustic and electromagnetic scattering

AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences)

Adaptive algebraic multigrid methods in lattice computations

PDEs, part 1: Introduction and elliptic PDEs

Numerical Solutions to Partial Differential Equations

Applied Linear Algebra in Geoscience Using MATLAB

Statistical Geometry Processing Winter Semester 2011/2012

Chapter 7. Canonical Forms. 7.1 Eigenvalues and Eigenvectors

linearly indepedent eigenvectors as the multiplicity of the root, but in general there may be no more than one. For further discussion, assume matrice

Introduction to Mathematical Physics

Foundations of Matrix Analysis

Linear Algebra review Powers of a diagonalizable matrix Spectral decomposition

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Algebra C Numerical Linear Algebra Sample Exam Problems

APPLIED NUMERICAL LINEAR ALGEBRA

Spectral theory of first order elliptic systems

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems

Lecture 7: Positive Semidefinite Matrices

MATHEMATICS. Course Syllabus. Section A: Linear Algebra. Subject Code: MA. Course Structure. Ordinary Differential Equations

Eigenvectors and Hermitian Operators

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA

Numerical Methods for Partial Differential Equations: an Overview.

Numerical Solutions to Partial Differential Equations

GROUP THEORY PRIMER. New terms: so(2n), so(2n+1), symplectic algebra sp(2n)

Linear Algebra review Powers of a diagonalizable matrix Spectral decomposition

MATRICES. a m,1 a m,n A =

Partial Differential Equations

Matrices and Vectors. Definition of Matrix. An MxN matrix A is a two-dimensional array of numbers A =

1 Last time: least-squares problems

MATHEMATICS FOR COMPUTER VISION WEEK 2 LINEAR SYSTEMS. Dr Fabio Cuzzolin MSc in Computer Vision Oxford Brookes University Year

Numerical Methods - Numerical Linear Algebra

The antitriangular factorisation of saddle point matrices

Basic Concepts in Linear Algebra

Compact symetric bilinear forms

3 2 6 Solve the initial value problem u ( t) 3. a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES)

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners

18.06 Problem Set 8 - Solutions Due Wednesday, 14 November 2007 at 4 pm in

Lecture 11: Finish Gaussian elimination and applications; intro to eigenvalues and eigenvectors (1)

CS 542G: Robustifying Newton, Constraints, Nonlinear Least Squares

Indefinite and physics-based preconditioning

Numerical Analysis for Nonlinear Eigenvalue Problems

Lecture 18 Classical Iterative Methods

ADVANCED ENGINEERING MATHEMATICS

Review of Basic Concepts in Linear Algebra

Nonlinear Eigenvalue Problems: An Introduction

1 Distributions (due January 22, 2009)

AMS526: Numerical Analysis I (Numerical Linear Algebra)

MATH 583A REVIEW SESSION #1

Matrix Factorizations

Index. C 2 ( ), 447 C k [a,b], 37 C0 ( ), 618 ( ), 447 CD 2 CN 2

Homework 2 Foundations of Computational Math 2 Spring 2019

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN

CONTENTS. Preface Preliminaries 1

Short title: Total FETI. Corresponding author: Zdenek Dostal, VŠB-Technical University of Ostrava, 17 listopadu 15, CZ Ostrava, Czech Republic

Chapter 7: Symmetric Matrices and Quadratic Forms

Math 408 Advanced Linear Algebra

Short note on compact operators - Monday 24 th March, Sylvester Eriksson-Bique

BASIC EXAM ADVANCED CALCULUS/LINEAR ALGEBRA

A TOUR OF LINEAR ALGEBRA FOR JDEP 384H

Partitioned Methods for Multifield Problems

Preface to Second Edition... vii. Preface to First Edition...

A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS

REPRESENTATION THEORY WEEK 5. B : V V k

Basic Principles of Weak Galerkin Finite Element Methods for PDEs

Nonlinear Eigenvalue Problems: Theory and Applications

1. Fast Solvers and Schwarz Preconditioners for Spectral Nédélec Elements for a Model Problem in H(curl)

Detailed Program of the Workshop

Transcription:

ADI iterations for general elliptic problems John Strain Mathematics Department UC Berkeley July 2013 1

OVERVIEW Classical alternating direction implicit (ADI) iteration Essentially optimal in simple domains Applies to narrow class of special elliptic equations Useful for variable-coefficient and nonlinear problems Generalize ADI to arbitrary elliptic systems Eliminate symmetry, commutativity, separability,... Solve Laplace, Helmholtz, Stokes,..., with single code Convert elliptic problems to first-order overdetermined form Control computational error via residuals Illuminate solvability of boundary value problem 2

CLASSICAL ALTERNATING DIRECTION IMPLICIT Separable second-order equations in rectangles u = Au + Bu = 1 2 u 2 2 u = f efficiently solved by essentially optimal ADI iteration (s + A)(s + B)u m+1 = (s A)(s B)u m + 2sf when A and B are commuting positive Hermitian operators Fast damping over geometric range a 0 1 2 b s 2 s a s + a 1 s b s + b 1 3 implies O(ɛ) error reduction in O(log N log ɛ) sweeps 3

FIRST AND SECOND ORDER ELLIPTIC PROBLEMS Cauchy-Riemann x u = y v y u = x v Low-frequency time-harmonic Maxwell E = iω c H E = 4πρ H = iω c E + 4π c j H = 0 Linear elasticity i σ ij + F j = 0 σ ij 1 2 C ijkl ( k u l + l u k ) = 0 Laplace/Poisson/Helmholtz/Yukawa/... u + λu = f Stokes u + p = f u = 0 4

CONVERTING TO FIRST-ORDER SYSTEMS Higher-order system of partial differential equations + ijl a ijkl i j v l + jl b jkl j v l + l c kl v l = f k in Ω l α kl v l + jl β kjl j v l + = g k on Γ = Ω Seek new solution vector u = (v, 1 v,..., d v,...) T Vector u satisfies first-order system Au = j A j j u + A 0 u = f in Ω Bu = g on Γ Sparse matrices A j, A 0, B localize algebraic structure 5

PITFALL OF CONVERSION Robin boundary value problem for 2D Poisson equation v + λv = f αv + β n v = g in Ω on Γ 3 3 square system Au = 1 1 0 2 0 1 λ 1 2 Bu = [ α βn 1 βn 2 ] v 1 v 2 v v 1 v 2 v = 0 0 f = g System not elliptic (in sense of Protter): principal part j k j A j = k 1 0 0 k 2 0 0 0 k 1 k 2 singular for all k! 6

SOLVED BY OVERDETERMINATION v + λv = f in Ω Overdetermined 4 3 elliptic system Au = 1 1 0 2 0 1 0 2 1 λ 1 2 v 1 v 2 v = 0 0 0 f Compatibility conditions overdetermined but elliptic j k j A j = k 1 0 0 k 2 0 0 0 k 2 k 1 0 k 1 k 2 full-rank injective for k 0 Analytical benefit: controls derivatives j u in terms of u and f Computational advantage: controls error via residuals 7

CONVERSION OF 2D STOKES Stokes for 2-vector u and scalar p u + p = f u = 0 Converts to 13 9 sparse system with u = u 1 u 1,1 u 1,2 u 2 u 2,1 u 2,2 p p,1 p,2 j k j A j = k 1 k 2 k 2 k 1 k 1 k 2 k 1 k 1 k 2 k 2 k 1 k 1 k 2 k 2 k 1 k 2 k 2 k 1 k 1 k 2 Elliptic (in sense of Protter) with Laplace equation p = f 8

BOUNDARY CONDITIONS FOR DERIVATIVES? Example: Dirichlet v = g Bu = g with rank-1 matrix B Intuitively, the system Au = f includes compatibility conditions Analytically, Fourier transform in half space well-posed Computational methods enforce compatibility conditions up to boundary stable Overdetermined interior underdetermined boundary 9

LOCAL SOLVABILITY FOR NORMAL DERIVATIVE Ellipticity of first-order system Au = j A j j u + A 0 u = f in Ω implies any normal part A n = j n j A j is left-invertible A n = (A n A n) 1 A n A n A n = I Determines any directional derivative n u = i n i i u = A n (f A T T u A 0 u) in terms of tangential derivatives A T T u = j A j j u A n n u = ij A i ( δij n i n j ) j u and zero-order data 10

SOLVE BOUNDARY VALUE PROBLEM With full tangential data plus elliptic system can integrate n u = A n (f A T T u A 0 u) inward to solve boundary value problem Boundary conditions Bu = [ α βn 1 βn 2 ] v 1 v 2 v = g BB = I determine local projection B Bu = B g on the boundary Boundary value problem constrains (I B B)u on boundary Contrast: hyperbolic systems blind characteristics 11

GENERALIZED ADI FOR POISSON SYSTEM Choose arbitrary sweep direction n and normalize j A j j u = ij A i (n i n j + δij n i n j ) j u = A n n u + A T T u Left-invert A n by ellipticity and damp on scale 1/s su m+1 + n u m+1 + B 0 u m+1 = su m B T T u m + A nf Error mode e ikt x damped by matrix symbol ρ(k) = s n (s + ik n + B 0 ) 1 (s ik T B T ) Spectral radius 0.9 S with S = O(log N) sweeps 12

SPECTRAL RADIUS FOR POISSON SYSTEM s=1 s=4 s = 16 s = 64 13

GENERALIZED ADI FOR YUKAWA SYSTEM Yukawa as first-order system u λu = f A j u j + A 0 u = f introduces nonzero eigenvalues ± λ of B 0 = A na 0 Divide by zero when s = λ Use matrix sign function K = s sgn(b 0 ) computed by Schur decomposition B 0 = UT U Ku m+1 + n u m+1 + B 0 u m+1 = Ku m B T T u m + A nf Spectral radius 0.9 S with λ = 10 14

SPECTRAL RADIUS FOR YUKAWA WITH λ = 10 s=1 s=4 s = 16 s = 64 15

GENERAL STRUCTURE Given operators A and B with cheap resolvents (si A) 1 and (si B) 1 find an efficient scheme for the solution of (A + B)u = f Underlies many computational problems where A is sparse and B is low-rank A and B are both sparse but in different bases fast schemes deliver A 1 and B 1 Challenging when A and B don t commute Solution very unlikely in this generality 16

ADI 2 APPROACH 1. A and B may not be invertible (or even square): square (A + B) (A + B)u = (A + B) f = g 2. Solve corresponding heat equation to get u as t t u = (A + B) (A + B)u + g 3. Discretize time and split ( I + sa A ) ( I + sb B ) u m+1 = ( I s(a B + B A) ) u m + sg to get u as t 4. Alternate directions for symmetric symbol ρ = (I + sb B) 1 (I + sa A) 1 (I 2s(A B + B A)) (I + sa A) 1 (I + sb B) 1 Similar with more operators A, B, C, D,... 17

ADI 2 FOR POISSON/YUKAWA/HELMHOLTZ Second-order equation overdetermined first-order system u + λu = f (A + B + C)u = A 1 1 u + A 2 2 u + A 0 u = f with high-frequency zero-order operator C = O(λ) Fourier mode (k 1, k 2 ) of error damped with symbol ρ = (I + sc C) 1 (I + sb B) 1 (I + sa A) 1 (I 2s(A B + A C + B A + B C + C A + C B)) (I + sa A) 1 (I + sb B) 1 (I + sc C) 1 ρ = 1 (1 + sk 2 1 )2 (1 + sk 2 2 )2 (1 + sλ 2 ) 2 1 is(λ + 1)bk 1 is(λ + 1)bk 2 is(λ + 1)bk 1 b 2 0 is(λ + 1)bk 2 0 b 2 where b = (1 + sλ 2 )/(1 + s) Eigenvalues of ρ bounded by 1, controlled by s for all λ 18

SPECTRAL RADIUS FOR HELMHOLTZ WITH λ = 1 s = 1/64 s = 1/16 s = 1/4 s = 1 19

CONCLUSIONS Conversion to first-order overdetermined systems yields analytical understanding of elliptic structure well-posed computational formulations fast iterations for numerical solution Coming attractions: fast spectral boundary integral methods efficient implicit methods for elliptic moving interfaces nonuniform fast Fourier transforms for geometric data optimized post-gaussian quadrature methods 20