Numerical Analysis and Methods for PDE I

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

A very short introduction to the Finite Element Method

M.Sc. in Meteorology. Numerical Weather Prediction

Numerical Solutions to Partial Differential Equations

INTRODUCTION TO PDEs

Finite difference method for elliptic problems: I

PDEs, part 1: Introduction and elliptic PDEs

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

Introduction to Partial Differential Equations

Chapter 3 Second Order Linear Equations

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

Introduction to Partial Differential Equations

AM 205: lecture 14. Last time: Boundary value problems Today: Numerical solution of PDEs

Lucio Demeio Dipartimento di Ingegneria Industriale e delle Scienze Matematiche

Introduction of Partial Differential Equations and Boundary Value Problems

Numerical Methods for Partial Differential Equations: an Overview.

Second Order Elliptic PDE

PIECEWISE LINEAR FINITE ELEMENT METHODS ARE NOT LOCALIZED

Partial Differential Equations

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

CONVERGENCE THEORY. G. ALLAIRE CMAP, Ecole Polytechnique. 1. Maximum principle. 2. Oscillating test function. 3. Two-scale convergence

Applied Math Qualifying Exam 11 October Instructions: Work 2 out of 3 problems in each of the 3 parts for a total of 6 problems.

Scientific Computing I

Weighted Residual Methods

Finite Difference Methods for Boundary Value Problems

An Introduction to Numerical Methods for Differential Equations. Janet Peterson

1. Differential Equations (ODE and PDE)

Week 01 : Introduction. A usually formal statement of the equality or equivalence of mathematical or logical expressions

Lecture Introduction

Scientific Computing: An Introductory Survey

SUPERCONVERGENCE PROPERTIES FOR OPTIMAL CONTROL PROBLEMS DISCRETIZED BY PIECEWISE LINEAR AND DISCONTINUOUS FUNCTIONS

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations

Weighted Residual Methods

Additive Manufacturing Module 8

Basic Aspects of Discretization

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

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

Poisson Solvers. William McLean. April 21, Return to Math3301/Math5315 Common Material.

Finite Element Clifford Algebra: A New Toolkit for Evolution Problems

Spline Element Method for Partial Differential Equations

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

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

Conservation and dissipation principles for PDEs

Partial Differential Equations

7 Hyperbolic Differential Equations

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

An a posteriori error estimate and a Comparison Theorem for the nonconforming P 1 element

Classification of partial differential equations and their solution characteristics

Second-Order Linear ODEs (Textbook, Chap 2)

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

Implementation of Sparse Wavelet-Galerkin FEM for Stochastic PDEs

Weak form of Boundary Value Problems. Simulation Methods in Acoustics

Maximum Principles for Parabolic Equations

SOLVING ELLIPTIC PDES

Local Mesh Refinement with the PCD Method

Some Aspects of Solutions of Partial Differential Equations

Finite difference methods for the diffusion equation

BOUNDARY-VALUE PROBLEMS IN RECTANGULAR COORDINATES

Mathematical Methods - Lecture 9

UNIVERSITY of LIMERICK OLLSCOIL LUIMNIGH

Diffusion on the half-line. The Dirichlet problem

CLASSIFICATION AND PRINCIPLE OF SUPERPOSITION FOR SECOND ORDER LINEAR PDE

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

Partial Differential Equations 2 Variational Methods

Mathématiques appliquées (MATH0504-1) B. Dewals, Ch. Geuzaine

Partial Differential Equations

Math 342 Partial Differential Equations «Viktor Grigoryan

Numerical Methods for PDEs

2 A Model, Harmonic Map, Problem

Partial Differential Equations

Solving Boundary Value Problems (with Gaussians)

General Technical Remarks on PDE s and Boundary Conditions Kurt Bryan MA 436

Computational Fluid Dynamics Prof. Dr. SumanChakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur

Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials

Numerical Methods for Engineers and Scientists

Aspects of Multigrid

Poisson Equation in 2D

Lecture 6: Introduction to Partial Differential Equations

CHAPTER 4. Introduction to the. Heat Conduction Model

Before we look at numerical methods, it is important to understand the types of equations we will be dealing with.

1. Introduction. We consider the model problem that seeks an unknown function u = u(x) satisfying

Traces, extensions and co-normal derivatives for elliptic systems on Lipschitz domains

MATH 353 LECTURE NOTES: WEEK 1 FIRST ORDER ODES

Reading: P1-P20 of Durran, Chapter 1 of Lapidus and Pinder (Numerical solution of Partial Differential Equations in Science and Engineering)

Partial Differential Equations

1 Discretizing BVP with Finite Element Methods.

Partial differential equations

Lecture 3 Partial Differential Equations

Introduction - Motivation. Many phenomena (physical, chemical, biological, etc.) are model by differential equations. f f(x + h) f(x) (x) = lim

ENO and WENO schemes. Further topics and time Integration

MA 201: Partial Differential Equations D Alembert s Solution Lecture - 7 MA 201 (2016), PDE 1 / 20

Introduction. J.M. Burgers Center Graduate Course CFD I January Least-Squares Spectral Element Methods

Stochastic homogenization 1

Lecture Notes on PDEs

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

Superconvergence of discontinuous Galerkin methods for 1-D linear hyperbolic equations with degenerate variable coefficients

Basic Principles of Weak Galerkin Finite Element Methods for PDEs

Dirichlet s principle and well posedness of steady state solutions in peridynamics

Green s Functions and Distributions

A globally convergent numerical method and adaptivity for an inverse problem via Carleman estimates

Transcription:

Numerical Analysis and Methods for PDE I A. J. Meir Department of Mathematics and Statistics Auburn University US-Africa Advanced Study Institute on Analysis, Dynamical Systems, and Mathematical Modeling of Biological Systems Dec. 2 Dec. 12, 2011 This project is supported by a grant from the NSF

Outline 1 Introduction 2 Partial Differential Equations 3 Discretization 4 Model Problem Finite Difference Discretization Homogenization and Weak Formulation Finite Element Discretization Finite Volume Discretization

Modeling Physical Problem The actual problem we want to study Mathematical Model Equations, usually o.d.e, or p.d.e., hence also continuous model, usually posed in an infinite dimensional space Approximate Model Equations, usually algebraic equations, hence also discrete model, usually posed in a finite dimensional space

Modeling and Simulation Physical Problem Mathematical Model Numerical Model Direct Simulation Finite Finite Differences Volumes Finite Elements Spectral Methods Particle Methods Algebraic Equations (linear or nonlinear)

Motivation Many processes in natural sciences, engineering, and economics (social sciences) are governed by partial differential equations (p.d.e.) The efficient numerical solution of such equations plays an ever-increasing role in state-of-the-art technology The enormous computing power available allows us to simulate real world problems Numerical approximation of solutions

Partial Differential Equations (P.D.E.) P.D.E. model many and various phenomena, but relatively few have closed form solutions A p.d.e. is an equation that contains partial derivatives of an unknown function u : Λ R The domain Λ R d with d 2 (if d = 1 it is an o.d.e.); Λ = Ω (0, T ) Poisson s equation Heat equation Wave equation Biharmoninc equation u = f u t u = f u tt u = f u = f We can also consider systems of p.d.e. u = d i=1 ux i x i

Partial Differential Equations More generally for a domain Ω R d 1 d 1 Lu = i=1 a ij (x) 2 d 1 u + x i x j i=1 b j (x) u x i + c(x)u Assume a ij = a ji, the differential operator L is elliptic if there exists a λ > 0 such that for all x Ω and ξ R d 1 d 1 d 1 a ij (x)ξ i ξ j λ i=1 i=1 ξ 2 i Elliptic equation Parabolic equation Hyperbolic equation Lu = f u t + Lu = f u tt + Lu = f

Partial Differential Equations Classification of P.D.E. Poisson s equation elliptic - equilibrium u = f u : Ω R Heat equation u t u = f parabolic - diffusion, decay u : Λ R Wave equation u tt u = f hyperbolic - propagation u : Λ R Note, here the domain Ω R d 1 and Λ = Ω (0, T ), later we will denote the boundary of Ω by Ω This classification is not exhaustive and p.d.e. may change type

Remarks In order to obtain a well posed problem we may have to supplement the p.d.e. with initial conditions (i.c.), boundary conditions (b.c.), or both (as appropriate) In this talk I will introduce the finite element method. Finite element methods may be used to solve elliptic, parabolic, and hyperbolic equations, (as well as first order systems, and other types of equations) although they were originally developed to approximate solutions of elliptic p.d.e. this is a misnomer it should be approximate solutions of We will initially look at the finite element method for elliptic p.d.e.

Discretization The basic idea behind any numerical method for approximating solutions of p.d.e. is to replace the continuous problem (p.d.e.) by a discrete problem Continuous problem (p.d.e.) - posed on an infinite dimensional space Discrete problem - posed on a finite dimensional space The solution lies in some infinite dimensional space The solution lies in some finite dimensional space

Common Discretizations Finite Difference Method - approximate the differential operator Finite Element Method - approximate the solution Finite Volume Method - write the equation in conservation form, approximate a conservation law Spectral Method - approximate the solution Spectral Element Method - approximate the solution Collocation Method - require that the equation hold at special points (collocation points)

Finite Elements The finite element method has been an astonishing success. It was created to solve the complicated equations of elasticity and structural mechanics, and for those problems it has essentially superseded the method of finite differences. Now other applications are rapidly developing. Whenever flexibility in geometry is important and the power of the computer is needed not only to solve a system of equations, but also to formulate and assemble the discrete approximation in the first place the finite element method has something to contribute. Gilbert Strang and George J. Fix (1973) Gilbert Strang, George Fix; An Analysis of the Finite Element Method, Second Edition, Wellesley-Cambridge Press (Distributed by SIAM) 2008.

Disclaimers I will try to illustrate the main ideas behind the finite element method (and maybe some other methods) All the statements I make can be made mathematically rigorous Can be extended to problems in d-dimensions Can be extended to more complex problems

History Finite difference methods Ancient Finite element methods Courant (1943) Argyris (1954), Turner (1956) Clough (1960) Engineering literature 1960 1970 (early developments), and 1970 Mathematics literature 1970

Finite Elements vs. Finite Differences Finite Elements - approximate the solution Replace p.d.e. by a weak formulation (variational problem; optimization problem) Approximate the solution by a function in a suitable finite dimensional function space Finite Differences - approximate the differential operator Replace p.d.e. by a difference equation Solve the difference equation

Model Problem 1-d Consider the model problem, Ω = (0, 1) u (x) + c(x)u(x) = f (x) x Ω with b.c. u(0) = g 0 u(1) = g 1 Note, this is a t.p.b.v.p. (not an i.v.p.) this is the 1-d (d.e.) analog of the p.d.e. u + cu = f in Ω with (Dirichlet) b.c. u Ω = g

Finite Difference Discretization Finite Difference Approximation u (x) u (x) u (x) u (x) u(x + h) u(x) h u(x) u(x h) h u(x + h) u(x h) 2h u(x + h) 2u(x) + u(x h) h 2 O(h) O(h) O(h 2 ) O(h 2 )

Finite Difference Discretization Finite Difference Mesh Finite difference mesh, or grid x i = ih i = 0, 1,... n + 1 h = 1 n + 1 1.2 1 0.8 0.6 0.4 0.2 0 x 0 x i x i+1 x n+1 0.2 0.2 0.1 0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1 1.1 1.2

Finite Difference Discretization Finite Difference Discretization Replace the equation for u u (x) + c(x)u(x) = f (x) x Ω with b.c. u(0) = g 0 u(1) = g 1 by algebraic equations for a grid function u h i = u h (x i ) and u h i 1 + 2uh i u h i+1 h 2 + c(x i )u h i = f (x i ) 1 i n u h 0 = g 0 u h n+1 = g 1

Finite Difference Discretization Finite Difference Approximation This is the system of algebraic equations (for c(x) = c, a constant) we get 1 h 2 2 + ch 2 1 1 2 + ch 2 1 1 2 + ch 2 1......... 1 2 + ch 2 u h 1 u h 2 u h 3. u h n = This system matrix is symmetric, positive definite, hence the system has a unique solution and u(x i ) u h i f 1 + g 0 h 2 f 2 f 3. f n + g 1 h 2

Finite Difference Discretization Homogenization Given with b.c. u (x) + c(x)u(x) = f (x) u(0) = g 0 u(1) = g 1 x Ω Find a function g such that g(0) = g 0 and g(1) = g 1 Set û = u g The function g must belong to some space of admissible functions

Homogenization and Weak Formulation Homogenization - Continued Solve the homogeneous problem û (x) + c(x)û(x) = ˆf (x) x Ω with b.c. where Then û(0) = 0 û(1) = 0 ˆf (x) = f (x) + g (x) c(x)g(x) u(x) = û(x) + g(x)

Homogenization and Weak Formulation Variational Lemma and Weak Derivative Variational Lemma Let v L 1 (Ω) loc, Ω R d nonempty, if v(x)φ(x) dx = 0 for all φ C0 (Ω) Ω then v = 0 a.e. in Ω Weak Derivative Let Ω R d nonempty, v, w L 1 (Ω) loc, then w is the weak α th derivative of v if v(x)d α φ(x) dx = ( 1) α w(x)φ(x) dx for all φ C0 (Ω) Ω Ω α = (α 1,... α d ) and D α = α x α 1 1... x α d d where α = d i=1 α i

Homogenization and Weak Formulation Weak Form Multiply the d.e. by a test function v and integrate over Ω = (0, 1) 1 0 [ û (x) + c(x)û(x)]v(x) dx = 1 0 ˆf (x)v(x) dx v in some appropriate function space V Integrating by parts we get 1 0 ( û (x) + c(x)û(x))v(x) dx = û (1)v(1) + û (0)v(0) + 1 0 û (x)v (x) + c(x)û(x)v(x) dx Here V = H 1 0 (0, 1), those unfamiliar with Sobolev spaces can think v C[0, 1] such that v is piecewise continuous and bounded on [0, 1] with v(0) = v(1) = 0

Homogenization and Weak Formulation Weak and Variational Formulations Define and (u, v) = 1 0 u(x)v(x) dx F (v) = 1 2 [(v, v ) + (cv, v)] (ˆf, v)

Homogenization and Weak Formulation Weak and Variational Formulations - Continued The weak problem is find û V such that (û, v ) + (cû, v) = (ˆf, v) for all v V The variational problem is find û V such that F (û) F (v) for all v V Then u = û + g is a weak (or variational) solution of the original problem If u is sufficiently regular, it is a strong solution, or a classical solution of the p.d.e.

Finite Element Discretization The Discrete Problem Construct a finite dimensional space V h V Solve the discrete weak (or variational problem) find û h V h such that (û h, v h ) + (cû h, v h ) = (ˆf, v h ) for all v h V h or find û h V h such that F (û h ) F (v h ) for all v h V h Then û h + g h is an approximation to u the solution of the p.d.e. (where g h is some approximation to g) This leads to, so called, conforming finite element methods, if this inclusion does not hold we have nonconforming finite elements

Finite Element Discretization Finite Elements Finite element mesh, or grid 0 = x 0 < x 1 <... < x n < x n+1 = 1 I i = (x i 1, x i ) h i = I i = x i x i 1 1.2 1 0.8 0.6 0.4 0.2 0 x 0 x i x i+1 x j 0.2 0.2 0 0.2 0.4 0.6 0.8 1 1.2

Finite Element Discretization Finite Elements h = max {h i} 1 i n+1 h is a measure of the size of the grid (the smaller h the finer the grid, higher resolution, more accurate solution, higher dimensional space)

Finite Element Discretization Linear Finite Element Space The simplest finite element space is that of continuous piecewise linear functions (which are zero at 0 and 1) A basis for V h can be constructed as follows φ j V h 1 j n φ j (x i ) = { 1 if i = j 0 if i j Obviously any v h V h can be written as v h (x) = n i=1 v h i φ i (x) for x [0, 1] where v h i = v h (x i )

Finite Element Discretization Linear Finite Elements Piecewise linear basis functions 1.2 1 0.8 φ i φ j 0.6 0.4 0.2 0 x 0 x i x i+1 x j 0.2 0.2 0 0.2 0.4 0.6 0.8 1 1.2

Finite Element Discretization Weak Form - Revisited (û h, v h ) + (cû h, v h ) = (ˆf, v h ) for all v h V h is equivalent to (û h, φ j) + (cû h, φ j ) = (ˆf, φ j ) for 1 j n n and substituting û h (x) = ûi h φ i (x) i=1 n ûi h [(φ i, φ j) + (cφ i, φ j )] = (ˆf, φ j ) for 1 j n i=1

Finite Element Discretization Algebraic System 1 h This (for c(x) = c, a constant) is the algebraic system 2 + 2ch2 3 1 + ch2 6 1 + ch2 6 2 + 2ch2 3 1 + ch2 6 1 + ch2 6 2 + 2ch2 3 1 + ch2 6......... 1 + ch2 6 2 + 2ch2 3 û h 1 û h 2 û h 3. This system matrix is symmetric, positive definite, hence the system has a unique solution and n u(x) u h (x) = û h (x) + g h (x) = ûi h φ i (x) + g h (x) i=1 û h n f 1 f 2 = f 3. f n

Finite Element Discretization Finite Elements vs. Finite Difference 1 h 2 2 + ch 2 1 1 2 + ch 2 1......... 1 2 + ch 2 u h 1 u h 2 u h 3. u h n = f 1 + g0 h 2 f 2 f 3. f n + g1 h 2 1 h u(x i ) u h i 2 + 2ch2 3 1 + ch2 6 1 + ch2 6 2 + 2ch2 3 1 + ch2 6......... 1 + ch2 6 2 + 2ch2 3 û h 1 û h 2 û h 3. û h n f 1 f 2 f 3. = f n n u(x) u h (x) = ûi h φ i (x) + g h (x) i=1

Finite Element Discretization Higher Order Elements 1.2 1.2 1.2 1 1 1 0.8 0.8 0.8 0.6 0.6 0.6 0.4 0.4 0.4 0.2 0.2 0.2 0 0 0 0.2 0.2 0.2 0.4 1 0 1 0.4 1 0 1 0.4 1 0 1

Finite Element Discretization Finite Elements vs. Finite Differences - Revisited Finite Elements - approximate the solution Replace p.d.e. by a weak formulation (variational problem; optimization problem) Approximate the solution by a function in a suitable finite dimensional function space Finite Differences - approximate the differential operator Replace p.d.e. by a difference equation Solve the difference equation

Finite Element Discretization Finite Elements vs. Finite Differences - Continued Finite Elements Complicated domains Variable material properties Nonlinear equations Rigorous theoretical foundations Finite Differences Simple (easy to program) Lower complexity (memory footprint) Easier to parallelize

Finite Volume Discretization Finite Volumes Recall the homogeneous model problem with b.c. where Then û (x) + c(x)û(x) = ˆf (x) x Ω û(0) = 0 û(1) = 0 ˆf (x) = f (x) + g (x) c(x)g(x) u(x) = û(x) + g(x)

Finite Volume Discretization Finite Volumes The main idea behind the finite volume method is the introduction of a flux for some quantity and writing conservation equation for that quantity. First consider the simpler problem with b.c. û (x) = ˆf (x) x Ω û(0) = 0 û(1) = 0 Introduce the flux F (x) = û and write the eq. in conservation form F = ˆf (x) x Ω F (x) = ˆf (x) x Ω

Finite Volume Discretization Finite Volumes Introduce a mesh, or grid 0 = x 0 = x 1/2 < x 1 < x 3/2 <... < x n < x n+1/2 = x n+1 = 1 I i = (x i 1/2, x i+1/2 ) h i = I i = x i+1/2 x i 1/2

Finite Volume Discretization Finite Volumes Conservation of F on each volume F (x)dx = I i I i ˆf (x)dx F (x i+1/2 ) F (x i 1/2 ) = ˆf (x)dx I i u (x i+1/2 ) + u (x i 1/2 ) = ˆf (x)dx I i

Finite Volume Discretization Finite Volumes We still need to approximate the fluxes F (x i+1/2 ) u(x i+1) u(x i ) x i+1 x i and the integral I i ˆf (x)dx h i ˆf (x i )

Finite Volume Discretization Finite Volumes Putting it all together F (x i+1/2 ) F (x i 1/2 ) = h i ˆf (x i ) i = 1,..., N where F (x i+1/2 ) u(x i+1) u(x i ) x i+1 x i u(x 0 ) = 0 u(x N+1 ) = 0 i = 0,..., N

Finite Volume Discretization Finite Volumes Back to our model problem we get F (x i+1/2 ) F (x i 1/2 ) + cu(x)dx = I i ˆf (x)dx I i approximating the integrals F (x i+1/2 ) F (x i 1/2 ) + h i û(x i ) = h i ˆf (x i )

Finite Volume Discretization Finite Volumes Ending up with F (x i+1/2 ) F (x i 1/2 ) + h i cu h (x i ) = h i ˆf (x i ) i = 1,..., N where F (x i+1/2 ) = uh (x i+1 ) u h (x i ) x i+1 x i u h (x 0 ) = 0 u h (x N+1 ) = 0 i = 0,..., N

Finite Volume Discretization Finite Volumes Finite Differences vs. Finite Elements vs. Finite Volumes 1 h 2 + ch 2 1 1 2 + ch 2 1......... 1 2 + ch 2 u h 1 u h 2 u h 3. u h n = h f 1 + g0 h 2 f 2 f 3. f n + g1 h 2 1 h 2 u(x i ) u h i 2 + ch 2 1 1 2 + ch 2 1......... 1 2 + ch 2 u(x i ) u h i u h 1 u h 2 u h 3. u h n = f 1 + g0 h 2 f 2 f 3. f n + g1 h 2

Finite Volume Discretization Finite Volumes Finite Differences vs. Finite Elements vs. Finite Volumes 1 h 2 + 2ch2 3 1 + ch2 6 1 + ch2 6 2 + 2ch2 3 1 + ch2 6......... 1 + ch2 6 2 + 2ch2 3 û h 1 û h 2 û h 3. û h n f 1 f 2 f 3. = f n n u(x) u h (x) = ûi h φ i (x) + g h (x) i=1