PDEs, part 1: Introduction and elliptic PDEs

Similar documents
INTRODUCTION TO PDEs

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

Partial Differential Equations

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of,

Chapter 12. Partial di erential equations Di erential operators in R n. The gradient and Jacobian. Divergence and rotation

Numerical Solutions to Partial Differential Equations

PDEs, part 3: Hyperbolic PDEs

Numerical Methods for PDEs

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

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

Outline. 1 Boundary Value Problems. 2 Numerical Methods for BVPs. Boundary Value Problems Numerical Methods for BVPs

Table of Contents. II. PDE classification II.1. Motivation and Examples. II.2. Classification. II.3. Well-posedness according to Hadamard

Lecture Introduction

Introduction to Partial Differential Equations

Lecture Notes on PDEs

Fundamental Solutions and Green s functions. Simulation Methods in Acoustics

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C.

Math 342 Partial Differential Equations «Viktor Grigoryan

From Completing the Squares and Orthogonal Projection to Finite Element Methods

1. Let a(x) > 0, and assume that u and u h are the solutions of the Dirichlet problem:

Classification of partial differential equations and their solution characteristics

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics

Numerical Analysis and Methods for PDE I

Module 7: The Laplace Equation

13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs)

Simple Examples on Rectangular Domains

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9

Homework for Math , Fall 2016

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

CLASSIFICATION AND PRINCIPLE OF SUPERPOSITION FOR SECOND ORDER LINEAR PDE

Linear Algebra, part 2 Eigenvalues, eigenvectors and least squares solutions

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids

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

Basic Aspects of Discretization

Second Order Elliptic PDE

Final Exam May 4, 2016

MATH 425, FINAL EXAM SOLUTIONS

PDE Solvers for Fluid Flow

Final: Solutions Math 118A, Fall 2013

An Introduction to Numerical Methods for Differential Equations. Janet Peterson

Additive Manufacturing Module 8

Scientific Computing I

Chapter 1: The Finite Element Method

Suggested Solution to Assignment 7

Mathematics of Physics and Engineering II: Homework problems

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

Partial differential equation for temperature u(x, t) in a heat conducting insulated rod along the x-axis is given by the Heat equation:

ACM/CMS 107 Linear Analysis & Applications Fall 2017 Assignment 2: PDEs and Finite Element Methods Due: 7th November 2017

Partial Differential Equations

Partial Differential Equations

Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White

Numerical Analysis and Computer Science DN2255 Spring 2009 p. 1(8)

M.Sc. in Meteorology. Numerical Weather Prediction

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

MATH COURSE NOTES - CLASS MEETING # Introduction to PDEs, Fall 2011 Professor: Jared Speck

MATH COURSE NOTES - CLASS MEETING # Introduction to PDEs, Spring 2018 Professor: Jared Speck

Lecture 1. Finite difference and finite element methods. Partial differential equations (PDEs) Solving the heat equation numerically

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V

LAPLACE EQUATION. = 2 is call the Laplacian or del-square operator. In two dimensions, the expression of in rectangular and polar coordinates are

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

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations

Lecture 3: Function Spaces I Finite Elements Modeling. Bruno Lévy

Numerical Solutions to Partial Differential Equations

Finite difference method for elliptic problems: I

Lucio Demeio Dipartimento di Ingegneria Industriale e delle Scienze Matematiche

Outline. 1 Partial Differential Equations. 2 Numerical Methods for PDEs. 3 Sparse Linear Systems

Math 4263 Homework Set 1

Boundary Value Problems and Iterative Methods for Linear Systems

Question 9: PDEs Given the function f(x, y), consider the problem: = f(x, y) 2 y2 for 0 < x < 1 and 0 < x < 1. x 2 u. u(x, 0) = u(x, 1) = 0 for 0 x 1

The Discontinuous Galerkin Finite Element Method

Partial Differential Equations

Spectral Processing. Misha Kazhdan

FEniCS Course. Lecture 0: Introduction to FEM. Contributors Anders Logg, Kent-Andre Mardal

11.3 MATLAB for Partial Differential Equations

Solving PDEs with freefem++

Numerical methods for the Navier- Stokes equations

Chapter 3 Variational Formulation & the Galerkin Method

A very short introduction to the Finite Element Method

Time-dependent variational forms

Tutorial 2. Introduction to numerical schemes

INTRODUCTION TO FINITE ELEMENT METHODS

Finite Difference Methods for Boundary Value Problems

Chapter 10. Function approximation Function approximation. The Lebesgue space L 2 (I)

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

CAAM 336 DIFFERENTIAL EQUATIONS IN SCI AND ENG Examination 1

Finite Elements. Colin Cotter. January 15, Colin Cotter FEM

1 Discretizing BVP with Finite Element Methods.

Finite difference methods for the diffusion equation

WELL POSEDNESS OF PROBLEMS I

Chapter 3. Second Order Linear PDEs

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN

A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS

Chapter 9: Differential Analysis of Fluid Flow

Finite difference method for solving Advection-Diffusion Problem in 1D

Waves on 2 and 3 dimensional domains

21 Laplace s Equation and Harmonic Functions

PARTIAL DIFFERENTIAL EQUATIONS. Lecturer: D.M.A. Stuart MT 2007

u(0) = u 0, u(1) = u 1. To prove what we want we introduce a new function, where c = sup x [0,1] a(x) and ɛ 0:

Numerical Solutions to Partial Differential Equations

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

Transcription:

PDEs, part 1: Introduction and elliptic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2013 Partial di erential equations The solution depends on several variables, and the equation contains partial derivatives with respect to these variables. Example: au xx + bu xy + cu yy =0, u = u(x, y). There are three main classes of well-posed PDEs. 1. Parabolic (b 2 4ac = 0). 2. Elliptic (b 2 4ac < 0). 3. Hyperbolic (b 2 4ac > 0).

Partial di erential equations 1. Parabolic PDEs I Model equation: ut = u xx.heatequationordi usion equation. I Phenomena: Di usion, smearing. Time dependent, goes to steady state (without forcing). I Physics: Heat conduction, di usion processes. 2. Elliptic PDEs I Model equation: u = uxx + u yy = f (x, y). (Poisson s equation, or with f =0,Laplace sequation). I Phenomena: Equilibrium. Stationary (t!1in parabolic). I Physics: Electric potential, potential flow, structural mechanics. 3. Hyperbolic PDEs I Model equation: utt = u xx (wave equation) and u t = u x (transport or advection equation). I Phenomena: Transport. Wave propagation. (time dependent, but no steady state). I Physics: Electromagnetic, acoustic, elastic waves. Well posedness for PDEs A PDE (together with the boundary conditions given) is well posed if 1. A solution exists. 2. The solution is unique. 3. The solution depend continuously on the data. Problems that are not well-posed are called ill-posed. The examples we have given here, are all well posed. Other examples: I Backward heat equation, t! t, ) u t = u xx. Going from a smooth solution to a highly peaked one. Very sensitive to initial data. Not well posed. I Boundary conditions are important: Not well posed. u t = u x, u(0) = u(1) = 0, u(x, 0) 6= 0.

Complications Our initial examples of PDEs models idealized situations. The reality is often more complicated, even if the most important phenomena are captured by the model equations. Examples: - Higher dimension. u t = u xx ) u t = u u = u(x, y, z, t). - Variable coe cients. u tt = u xx ) u tt = c(x) 2 u xx. - System of equations. u t = u x ) ū t = Aū x, ū 2 R n. - Non-linearities. u t = u x ) ū t = f (u) x, (u t = f 0 (u)u x ). - Lower order terms. u xx = f (x) ) u xx + u = f (x). - Source terms. u t = u xx ) u t = u xx + f (x). - Combinations from all of the above. Important PDE Example: Navier-Stokes equations for incompressible viscous flow. u t +(u r)u = u rp + f r u =0, u velocity, p pressure, kinematic viscosity ( = µ/, µ dynamic viscosity, density.) Very much used PDE, central to the field of fluid mechanics. But: very di cult to analyze, and also often to solve numerically (depending on parameters, geometry, and if additional physics is added.). Well-posedness has not been proven in 3D. (One million USD to anyone who proves (or dis-proves) this! http://www.claymath.org/millennium/) Solving PDEs extremely useful for modeling and understanding di erent physical processes. Usually too complicated to solve analytically. Very important to be able to do so numerically. Want robustness and accuracy!

Elliptic equations Strang, Chapter 3.1-3.4. Model equation: The Poisson equation in a domain R d. u = f (x) u(x) =g(x) x 2 x 2 @ Model for equilibrium problems, not time-dependent. This problem is well-posed, it has a unique stable solution (if f and @ nice enough. If f 0, we have Laplace s equation. Solutions to Laplace s equation are called harmonic functions. Examples of applications: Electrostatics, steady fluid flow, analytic functions,... Poisson s equation with Neumann boundary conditions When we set the value of u at the boundary, we have Dirichlet boundary conditions. With Neumann boundary conditions, u = f (x) x 2, @u(x) = h(x) x 2 @, we need to impose an additional condition to ensure that a solution exists, and also in this case the solution is only determined up to a constant. We need (follows from the divergence theorem) h(x)ds = f (x)dx. @

Laplace s equation Solutions to Laplace s equation are called harmonic functions. Maximum principle: Let be a connected open bounded set in R d, d = 2 or 3. Let u(x) :R d! R be a harmonic function in that is continuous on = [ @. Then the maximum and minimum values of u are attained on @ and nowhere inside (unless u constant). The maximum principle can e.g. be used to prove uniqueness to the Poisson problem with Dirichlet boundary conditions. Translation invariance: The Laplacian is invariant under all rigid motions in space, i.e any combination of translations and rotations. We have u = u xx + u yy + u zz = u x 0 x 0 + u y 0 y 0 + u z 0 z 0 = 0 u. (To show, use that any rotation in 3D is given by x 0 = Bx, whereb is an orthogonal matrix). Well known theorems/identities 1. The divergence (Gauss) theorem: r f dx = @ f n ds, where @ is a closed surface, f a vector valued function, and n outward unit normal. 2. Green s first identity (G1) ( @u = n ru): v @u ds = rv rudx + @ v udx 3. Green s second identity (G2): (u v v u) dx = @ u @v v @u ds where @u = n ru. (Use (G1) for u, v, thenforv, u, subtract).

Representation formula This formula represents any harmonic function as an integral over the boundary. if u =0in, then u(x 0 )= 1 4 @ u(x) @ 1 x x 0 + 1 x x 0 @u ds, x 0 2. If you know the values of u at the boundary, you can hence compute the value of u anywhere inside the domain. - Special case of (G2) with the choice of v(x) =( 4 x x 0 ) 1. - RHS agrees with RHS of (G2). - We have assumed u = 0, and v =0forx 6= x 0 (Check it!). - Simply inserting u = 0, and v = 0 into LHS of (G2) yields 0. Where does the left side of this formula come from? [notes] Fundamental solution - The fundamental solution, or free space Green s function for Laplace s equation obeys the equation: G = (x x 0 ). - This R means that for any volume V that encloses x 0 : Gdx = 1. V - AsimplewaytofindG is based on the fact that the Laplace equation is invariant under rotation, i.e. G function of x x 0 only. The result is (notes): G(x x 0 )= 1 4 x x 0. Note: this is for R 3, the Green s function in R 2 has a logarithmic singularity. Hence, the v(x) used to obtain the representation formula was this fundamental solution. (Modulo a sign).

Analytic solutions by separation of variables In some simple geometries, Laplace s equation can be solved by the technique of separation of variables. Examples: - In a square: Separation in x and y. - In a circle. Write Laplace s equation in polar coordinates, separate in r and. (See Strang, Sec 4.1, p 276 and Sec 5.5, p 458.) Separation of variables and the Poisson formula for a circle u =0 u = h( ) forx 2 + y 2 < a for x 2 + y 2 = a Solution - see notes. Plugging in the expression of the Fourier coe cients into the Fourier series, one is actually able to sum this explicitly, using the formula for a geometric series: 1X n = n=1 The result is the Poisson formula: u(r, ) = (a2 r 2 ) 2 1 1 as applied to X 2 0 n=1 r a n e in h( ) a 2 2ar cos( )+r 2 d

Finite di erences Assume we want to solve Poisson s equation in a rectangle, [0, L x ] [0, L y ]. 1. Define a computational grid with points (x i, y j )=(i x, j x), 0 apple i apple N + 1, 0 apple i apple M + 1. (Assume that dimensions of domain such that we can have the same grid size in both directions). 2. Replace the Laplacian with divided di erences. Second order approximation yields the five point formula. Di erence equations for all internal grid points. 3. Discretize the boundary conditions. 4. Order the unknowns in a vector, and collect the equations to express the system as a linear system of equations on matrix form, Au = b, where A is a sparse matrix with five non-zero diagonals. 5. Solve the linear system of equations to obtain your approximative solution. Notes for details. Analysis of this finite di erence method - Define the local truncation error as the residual of the exact solution inserted into the finite di erence equation. - Taylor expansion yields kl = O( x 2 ). - We say that the method is consistent if 1! 0 when x! 0, and of order p if 1 = O( x p ). - The five point formula is second order accurate. - Numerical solution vector u solution to Au = b. - Exact solution vector ũ solution to Aũ = b +( x) 2, where vector of truncation errors. - The error e = ũ u is a solution to Ae =( x) 2, andhence e =( x) 2 A 1. - kek apple( x) 2 ka 1 kk k applec 1 ( x) 4 ka 1 k. - Can show that ka 1 k < C 2 /( x) 2. (Eigenvalues of A explicitly known. Using that for a symmetric matrix, ka 1 k = (A 1 )=1/ min,where min is the smallest eigenvalue of A. ) - Hence, kek applec( x) 2.

Finite element methods Consider the one-dimensional elliptic problem (boundary value problem) d dx a(x)du dx + b(x)u = f (x) x 2 (0, 1) u(0) = u(1) = 0, with a(x) > 0, b(x) 0in[0, 1]. Multiply by a test function v 2 C 1 and integrate. Integration by parts and use of BCs yield the weak form: B(u, v) =hf, vi where B(u, v) isthebilinearformb(u, v) = R 1 0 (au xv x + buv) dx, and the L 2 inner product hf, vi = R 1 fv dx. 0 The solutions to the strong and the weak form are equivalent, if B(u, v) =hf, vi for all v 2 H0 1(0, 1), where the Sobolev space H1 0 (0, 1) is defined as H 1 0 (0, 1) := {v 1 0 (v 2 +(v 0 ) 2 )dx < 1, v(0) = v(1) = 0}. Notes for details. Minimization If we have symmetry such that B(u, v) =B(v, u), then the weak formulation is equivalent to the minimization problem Find u 2 H0 1 such that J(u) =min v2h0 1 J(v), where J(v) = 1 2B(v, v) hf, vi. In equilibrium, the energy of the system attains a minimum, and this is the solution that we are after. In our example, with a =1andb = 0, J(v) = 1 0 1 2 (v 0 ) 2 fv dx.

Galerkin s method Based on the weak form (or variational form) of the equation. 1. Approximate H 1 0 (0, 1) by a finite dimensional subspace V m H 1 0. 2. Exchange H 1 0 by V m in the weak formulation and solve Find ũ 2 V m s.t. B(ũ, v m )=hf, v m i 8v m 2 V m. Yields a solution ũ that approximates the exact solution u. 3. Assume that V m is m-dimensional and let ' 1, ' 2,...,' m be linearly independent basis functions for V m,i.e. V m = span{' 1, ' 2,...,' m } In FEM, basis functions ' i normally local piecewise polynomial functions. In spectral methods, one works with trigonometric polynomials. 4. Let ũ(x) = P m j=1 u j' j (x) and pick an arbitrary function in V m, v m (x) = P m j=1 v j' j (x) 2 V m.pluginandusethefactthatthe equation should hold for all v m 2 V m.thisyields Au = b, where (A) ij = B(' i, ' j )andb i = hf, ' i i. Galerkin s method, contd. I The residual of the Galerkin solution is orthogonal to all of V m. I One can show that is the original problem is elliptic, then A is symmetric and positive definite and the system Au = b has a unique solution. I If the basis functions ' j have compact support, we will have a ij = B(' i, ' j ) = 0 for many combinations i, j, whenthesupportsdo not overlap. See example with linear hat-fcns: tri-diagonal A for this 1D problem. Trigonometric functions are not local, give full matrix.

FEM in 2D. Consider Poisson s equation u = f u =0 x 2 x 2 @ The weak form is B(u, v) =hf, vi 8v 2 H0 1 with B(u, v) = ru rv dx hf, vi = fv dx Introduce a triangulation of, wtihnodes{x j }. As basis functions for approximate space V m, use tent or pyramid functions instead of hat functions. Still piecewise linear, but now bilinear. (Of course, can use higher order piecewise polynomials for higher order accuracy). Remarks on FEM I Easier to handle complex geometries as compared to Finite Di erence methods. Need to triangulate domain (2D) or define tetrahedras 3D. Once this is done, the framework is in place. I Theory for FEM/Galerkin is identical in higher dimensions. O ers tools for error estimation. I Spatial adaptivity based on error estimation is relatively simple. (Smaller triangles where derivatives of solution large, and more sophisticated versions thereof, depending on computed quantity of interest. )