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

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

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

A butterfly algorithm. for the geometric nonuniform FFT. John Strain Mathematics Department UC Berkeley February 2013

Math 302 Outcome Statements Winter 2013

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

Solving Boundary Value Problems (with Gaussians)

PDEs, part 1: Introduction and elliptic PDEs

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends

Linear Algebra Massoud Malek

Basic Principles of Weak Galerkin Finite Element Methods for PDEs

1 Distributions (due January 22, 2009)

Finite difference method for elliptic problems: I

Numerical Solutions to Partial Differential Equations

Aspects of Multigrid

Finite Elements. Colin Cotter. February 22, Colin Cotter FEM

Solving PDEs with Multigrid Methods p.1

Kasetsart University Workshop. Multigrid methods: An introduction

Scientific Computing: An Introductory Survey

Simple Examples on Rectangular Domains

Numerical Solutions to Partial Differential Equations

FINITE-DIMENSIONAL LINEAR ALGEBRA

Integral Representation Formula, Boundary Integral Operators and Calderón projection

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

AMS526: Numerical Analysis I (Numerical Linear Algebra)

Adaptive algebraic multigrid methods in lattice computations

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

Numerical Approximation Methods for Non-Uniform Fourier Data

In this chapter we study elliptical PDEs. That is, PDEs of the form. 2 u = lots,

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

Statistical Geometry Processing Winter Semester 2011/2012

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN

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

Computation Fluid Dynamics

Spectral Processing. Misha Kazhdan

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

Fast and accurate methods for the discretization of singular integral operators given on surfaces

INTRODUCTION TO PDEs

1 Infinite-Dimensional Vector Spaces

u xx + u yy = 0. (5.1)

Fourier series on triangles and tetrahedra

Practical Linear Algebra: A Geometry Toolbox

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

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

n 1 f n 1 c 1 n+1 = c 1 n $ c 1 n 1. After taking logs, this becomes

A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS

Partial Differential Equations

A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators

Mathematical Tripos Part IA Lent Term Example Sheet 1. Calculate its tangent vector dr/du at each point and hence find its total length.

Polynomial Approximation: The Fourier System

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations

Multigrid Methods and their application in CFD

Applied Linear Algebra

Geometric Multigrid Methods for the Helmholtz equations

( nonlinear constraints)

Partial Differential Equations and the Finite Element Method

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1

Numerical Solutions to Partial Differential Equations

Qualification Exam: Mathematical Methods

6. Iterative Methods for Linear Systems. The stepwise approach to the solution...

Lent 2019 VECTOR CALCULUS EXAMPLE SHEET 1 G. Taylor

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

Constructing Approximation Kernels for Non-Harmonic Fourier Data

Mixed Finite Elements Method

ADVANCED ENGINEERING MATHEMATICS MATLAB

Stabilization and Acceleration of Algebraic Multigrid Method

Math 307 Learning Goals. March 23, 2010

Linear Algebra. Session 8

Fast Iterative Solution of Saddle Point Problems

The Conjugate Gradient Method

for compression of Boundary Integral Operators. Steven Paul Nixon B.Sc.

NUMERICAL COMPUTATION IN SCIENCE AND ENGINEERING

Foundations of Matrix Analysis

Contents. Part I Vector Analysis

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications)

1. Fast Iterative Solvers of SLE

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction

Code: 101MAT4 101MT4B. Today s topics Finite-difference method in 2D. Poisson equation Wave equation

Lecture No 1 Introduction to Diffusion equations The heat equat

1 Assignment 1: Nonlinear dynamics (due September

Final Exam May 4, 2016

Numerical Methods for Partial Differential Equations

Scientific Computing I

Advanced. Engineering Mathematics

Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems

Generated sets as sampling schemes for hyperbolic cross trigonometric polynomials

Mathematical Preliminaries

Fourier Reconstruction from Non-Uniform Spectral Data

2 Two-Point Boundary Value Problems

Topics in Fourier analysis - Lecture 2.

Scientific Computing WS 2018/2019. Lecture 15. Jürgen Fuhrmann Lecture 15 Slide 1

Motivation: Sparse matrices and numerical PDE's

1 Exercise: Linear, incompressible Stokes flow with FE

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends

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

Numerical Solutions to Partial Differential Equations

Geometric Modeling Summer Semester 2012 Linear Algebra & Function Spaces

INDEX. Bolzano-Weierstrass theorem, for sequences, boundary points, bounded functions, 142 bounded sets, 42 43

A Fast Fourier transform based direct solver for the Helmholtz problem. AANMPDE 2017 Palaiochora, Crete, Oct 2, 2017

Lecture 18 Classical Iterative Methods

Metrisability of Painleve equations and Hamiltonian systems of hydrodynamic type

Transcription:

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

OVERVIEW Convert elliptic problems to first-order overdetermined form Control error via residuals Understand solvability of boundary value problem Generalize classical ADI iteration Essentially optimal in simple domains Eliminate symmetry and commutativity restrictions Reconstruct classical potential theory Employ Fourier analysis and Ewald summation Build fast boundary integral solvers in complex domains 2

Cauchy-Riemann EXAMPLES OF ELLIPTIC PROBLEMS x u = y v y u = x v Low-frequency 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 + su = f Stokes u + p = f u = 0 3

PART 1. 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 4

SQUARE BUT NOT ELLIPTIC Robin boundary value problem for 2D Poisson equation v = f αv + β n v = g in Ω on Γ 3 3 square system Au = 1 1 0 2 0 1 0 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! 5

OVERDETERMINED BUT ELLIPTIC v = f in Ω Overdetermined 4 3 elliptic system Au = 1 1 0 2 0 1 0 2 1 0 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 Analysis: controls derivatives j u in terms of u and f Computation: controls error via residuals 6

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 7

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 8

PART 2. 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 (h + A)(h + B)u m+1 = (h A)(h B)u m + 2f when A and B are commuting positive Hermitian operators Fast damping over geometric range a 0 1 2 b h 2 h a h + a 1 h b h + b 1 3 implies O(ɛ) error reduction in O(log N log ɛ) sweeps 9

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/h hu m+1 + n u m+1 + B 0 u m+1 = hu m B T T u m + A n f Error mode e ikt x damped by matrix symbol ρ(k) = h n (h + ik n + B 0 ) 1 (h ik T B T ) Spectral radius 0.9 M with M = O(log N) sweeps 10

SPECTRAL RADIUS FOR POISSON SYSTEM h=1 h=4 h = 16 h = 64 11

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

ADI SQUARED A and B may not be invertible (or even square), so square (A + B) (A + B)u = (A + B) f = g Solve corresponding heat equation to get u as t t u = (A + B) (A + B)u + g Discretize time and split ( I + ha A ) ( I + hb B ) u m+1 = ( I h(a B + B A) ) u m + g to get u + O(h) as t Alternate directions for symmetric symbol ρ = (I + hb B) 1 (I + ha A) 1 (I 2h(A B + B A)) (I + ha A) 1 (I + hb B) 1 Similar with more operators A, B, C, D,... 13

POISSON/YUKAWA/HELMHOLTZ Second-order equation overdetermined first-order system u + su = 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(s) Fourier mode (k 1, k 2 ) of error damped with symbol ρ = (I + hc C) 1 (I + hb B) 1 (I + ha A) 1 (I 2h(A B + A C + B A + B C + C A + C B)) (I + ha A) 1 (I + hb B) 1 (I + hc C) 1 ρ = 1 (1 + hk 2 1 )2 (1 + hk 2 2 )2 (1 + hs 2 ) 2 1 ih(s + 1)bk 1 ih(s + 1)bk 2 ih(s + 1)bk 1 b 2 0 ih(s + 1)bk 2 0 b 2 where b = (1 + hs 2 )/(1 + h) Eigenvalues of ρ bounded by 1 and controlled by h for all real s 14

SPECTRAL RADIUS FOR HELMHOLTZ WITH s = 1 h = 1/64 h = 1/16 h = 1/4 h = 1 15

PART 3. POTENTIAL THEORY Given fundamental matrix G x (y) of adjoint system d j=1 j G x (y)a j + G x (y)a 0 = δ x (y)i in box Q Ω Gauss theorem ( Gx (y)a j u(y) ) dy = Ω j Γ n j(γ)g x (γ)a j u(γ) dγ and general jump condition δ x 2 1 δ γ as x γ Γ implies universal boundary integral equation 1 2 u(γ) + G γ(σ)a n (σ)u(σ) dσ = Ωf(γ) on Γ Γ with normal part A n (γ) = n j (γ)a j and volume potential Ωf(γ) = Ω G γ(y)f(y) dy 16

PROJECTED INTEGRAL EQUATION Project out boundary condition Bu = g with P (γ) = I B B Solve well-conditioned square integral equation 1 2 µ(γ) + P (γ)g γ(σ)a n (σ)µ(σ)dσ = ρ(γ) Γ for locally projected unknown µ = P u with data ρ(γ) = P (γ)ωf(γ) P (γ)γb g(γ) and layer potential Γg(γ) = Γ G γ(σ)a n (σ)g(σ) dσ Recover u = µ + B g locally on Γ and then globally u(x) = Ωf(x) + Γu(x) in Ω Need algorithms for computing ρ, µ and u 17

PERIODIC FUNDAMENTAL SOLUTION Fourier series in cube Q Γ gives fundamental matrix G x (y) = e ikt x s(k) 1 a (k)e ikt y k Z d where s = a a is positive definite Hermitian matrix and a(k) = i d j=1 k j A j + A 0 Diverges badly since s(k) 1 a (k) = O( k 1 ) Local filter e τs gives exponential convergence G x (y) = e ikt x e τs(k) s(k) 1 a (k)e ikt y k N + tiny truncation error O(e τn2 ) + big but local filtering error O(τ) 18

GENERALIZED EWALD SUMMATION Fundamental matrix is smooth rapidly-converging series G τ (x) = e τs(k) s(k) 1 a (k)e ikt x = e τs S 1 A plus local asymptotic series for correction L τ = (I e τs )S 1 A = ( τ τ 2 2! S + τ 3 3! S2 with local differential operators A and S = A A ) A Implies local corrections and Ewald formulas (with special function kernels) for Laplace, Stokes,... Convergence independent of data smoothness yields volume and layer potentials Splits integral equation into sparse plus low-rank A + B 19

LOCAL CORRECTION BY GAUSS Gauss theorem differentiates indicator function ω(x) of set Ω ju dx = n ju dγ j ω = n j δ Γ Ω Γ Geometry in second-order derivatives j k ω(x) = ( j n k )δ Γ + n j n k n δ Γ Volume potential of discontinuous function f ω splits Ωf(x) = Ω G x(y)f(y) dy = Q(fω) = Q τ (fω) + L τ (fω) Local correction L τ satisfies product rule L τ (fω)(x) = τ (A f(x))ω(x) A j f(x)n j(x)δ Γ (x) + O(τ 2 ) j 20

SPECTRAL INTEGRAL EQUATION Fourier series for fundamental matrix separates variables G τ (x y) = e ikt x e τs(k) s(k) 1 a (k)e ikt y Converts integral equation to semi-separated form ( ) 1 2 + MRT µ(γ) = ρ(γ) T computes Fourier coefficients of (A n µ)δ Γ R applies filtered inverse of elliptic operator in Fourier space M evaluates and projects Fourier series on Γ Solve in Fourier space by identity ( ) 1 1 2 + MRT = 2 2MR ( ) 1 1 2 + T MR T Compresses integral operator to low-rank matrix (T MR) kq = Γ A n(σ)p (σ)e i(k q)t σ dσ e τs(q) s(q) 1 a (q) 21

NONUNIFORM FAST FOURIER TRANSFORM Standard FFT works on uniform equidistant mesh Nonuniform FFT works on arbitrary point sources: form coefficients for small source for large target spans butterfly: merge source and shorten target span recursively evaluate total of large source fields in small target spans Integral operator and density ρ require Fourier coefficients of soup of piecewise polynomials P j on simplices T j (points, segments, triangles, tetrahedra,... ) ˆf(k) = j T j e ikt x P j (x) dx 22

GEOMETRIC NONUNIFORM FFT Geometric NUFFT evaluates Fourier coefficients of soup in arbitrary dimension and codimension Follow model of NUFFT for point sources, but integrate polynomials over d-dimensional source simplices and d-dimensional target simplices to apply exact transform in D dimensions Dimensional recursion evaluates Galerkin matrix element F (k, d, S, P, α, σ) = (x S σ)α e ikt x P (x) dx in terms of lower-dimensional simplex faces F (k, d 1, j S, P, α, σ) lower-degree differentiated polynomials F (k, d, S, j P, α, σ) lower-order moments F (k, d, S, P, α e j, σ) 23

CONCLUSION Solve general elliptic problems in first-order overdetermined form with fast iterations in simple domains or projected boundary integral equation generalized Ewald summation geometric nonuniform fast Fourier transforms 24