Resources. Introduction to the finite element method. History. Topics

Size: px
Start display at page:

Download "Resources. Introduction to the finite element method. History. Topics"

Transcription

1 Resources Introduction to the finite element method M. M. Sussman Office Hours: 11:1AM-12:1PM, Thack 622 May 12 June 19, 214 Strang, G., Fix, G., An Analysis of the Finite Element Method 2nd Edition, Wellesley-Cambridge Press, 28 FEniCS Book: Volume 84 of Springer Lecture Notes in Computational Science and Engineering series: Anders Logg, Kent-Andre Merdal, Garth Wells, Automated Solution of Differential Equations by the Finite Element Method ISBN: (Print) (Online) +download/fenics-book final.pdf FreeFem++ Book: Reference: Hecht, F. New development in freefem++. J. Numer. Math. 2 (212), no. 3-4, Y15 Zienkiewicz, O. C., The Finite Element Method in Engineering Science, McGraw-Hill, / 34 2 / 34 Topics History Roots of method found in math literature: Rayleigh-Ritz Popularized in the 195s and 196s by engineers based on engineering insight with an eye toward computer implementation Winning idea: based on low-order piecewise polynomials with increased accuracy coming from smaller pieces, not increasing order. First use of the term Finite element in Clough, R. W., The finite element in plane stress analysis, Proc. 2dn A.S.C.E. Conf. on Elecronic Computation, Pittsburgh, PA, Sept Strang and Fix, first 5 pages: introduction 3 / 34 4 / 34

2 Topics Generalized derivatives Definition The space of C (Ω) functions whose support is a compact subset of Ω is denoted C (Ω) If a function f is differentiable, then df Ω dx φdx = Ω f dφ dx for all φ C. Definition If f is a measurable function and if there is a measurable function g satisfying Ω gφdx = Ω f dφ dx for all φ C, then g is said to be the generalized derivative of f. L 2 5 / 34 H k 6 / 34 Suppose Ω is a domain in R n u L 2 (Ω) u 2 = L 2 Ω u 2 < L 2 (Ω) is a Hilbert space with the inner product (u, v) = Ω uv L 2 (Ω) is the completion of C(Ω) under the inner product. L 2 contains functions that are measurable but continuous nowhere. A seminorm is given by u 2 k = D k u 2, where D k is any derivative of total order k H k is the completion of C k under the norm u 2 k = k i= u 2 k H = L 2 In 1D, functions in H 1 are continuous, but derivatives are only measurable. In dimensions higher than 1, functions in H 1 may not be continuous Functions in H 1 (Ω) have well-defined trace on Ω. 7 / 34 8 / 34

3 Topics A 2-point BVP d dx ( p(x) du ) + q(x)u = f (x) dx u() = du dx (π) = (BVP) Shape of a rotating string Temperature distribution along a rod 9 / 34 1 / 34 Theory Theory Suppose f L 2 (finite energy) Define linear operator L : HB 2 L2 L : u f from (BVP) Suppose f L 2 (finite energy) Define linear operator L : HB 2 L2 L is SPD L is 1-1 L : u f from (BVP) For each f L 2, (BVP) has a unique solution u H 2 B u 2 C f 11 / / 34

4 A solution Variational form: minimization Assume p > and q are constants Orthonormal set of eigenvalues, eigenfunctions Expand λ n = p(n 1 2 )2 + q u n (x) = f (x) = π a n 2 sin(n 1 2 )x n=1 Converges in L 2 since f 2 = a n < f need not satisfy b.c. pointwise! Solution π 2 sin(n 1 2 )x Solving Lu = f is equivalent to minimizing I(v) = (Lv, v) 2(f, v) (f, v) = π f (x)v(x) dx (Lv, v) = π [ (pv ) + qv]v dx u = a n pi u n = λ n 2 a n sin(n 1 2 )x p(n 1 2 )2 + q Variational form: minimization 12 / 34 Variational form: minimization 13 / 34 Solving Lu = f is equivalent to minimizing I(v) = (Lv, v) 2(f, v) (f, v) = π f (x)v(x) dx (Lv, v) = π [ (pv ) + qv]v dx Integrating by parts: (Lv, v) = π [p(v ) 2 + qv 2 ] dx [pv v] π v satisfies b.c. Solving Lu = f is equivalent to minimizing I(v) = (Lv, v) 2(f, v) (f, v) = π f (x)v(x) dx (Lv, v) = π [ (pv ) + qv]v dx Integrating by parts: (Lv, v) = π [p(v ) 2 + qv 2 ] dx [pv v] π v satisfies b.c. [p(x)(v (x)) 2 + q(x)v(x) 2 2f (x)v(x)] dx 13 / / 34

5 Variational form: stationary point Enlarge the search space Solving Lu = f is equivalent to finding u so that (Lu, v) = (f, v) for all v. Integrating by parts: (Lu, v) = π [p u v + q uv] dx [puv ] π Assume u and v satisfy b.c. a(u, v) = π [p u v + q uv] dx = (f, v) Enlarge space to any function that is limit of functions in H 2 B in the sense that I(v v k ) Only need H 1 Only the essential b.c. (v() = ) survives! Admissible space is H 1 E Solution function will satisfy both b.c. Euler equation from minimization of I(u) 14 / / 34 Why only essential b.c.? Relaxing space of f f can now come from H 1 Functions whose derivatives are L 2 (also written H ) L : HE 1 H 1 Dirac delta function! From Strang and Fix. 16 / / 34

6 Topics Start from the (minimization) variational form Replace HE 1 with sequence of finite-dimensional subspaces S h HE 1 Elements of S h are called trial functions Ritz approximation is minimizer u h I(u h ) I(v k ) v k S h Example: Eigenvectors as trial functions Assume p, q > are constants [p (v ) 2 + qv 2 2fv] dx Choose eigenfunctions = 1, 2,..., N = 1/h φ (x) = π 2 sin( 1 2 )x with eigenvalues λ = p( 1 2 )2 + q φ (x) 18 / 34 Example: Eigenvectors as trial functions Assume p, q > are constants [p (v ) 2 + qv 2 2fv] dx Choose eigenfunctions = 1, 2,..., N = 1/h φ (x) = π 2 sin( 1 2 )x with eigenvalues λ = p( 1 2 )2 + q φ (x) Plug in I(v k ) = N 1 [(v k ) 2 λ 2 π fv k φ dx] 19 / 34 2 / 34 2 / 34

7 Example: Eigenvectors as trial functions Assume p, q > are constants [p (v ) 2 + qv 2 2fv] dx Choose eigenfunctions = 1, 2,..., N = 1/h φ (x) = π 2 sin( 1 2 )x with eigenvalues λ = p( 1 2 )2 + q φ (x) Plug in I(v k ) = N 1 [(v k ) 2 λ 2 π fv k φ dx] Example: Eigenvectors as trial functions Assume p, q > are constants [p (v ) 2 + qv 2 2fv] dx Choose eigenfunctions = 1, 2,..., N = 1/h φ (x) = π 2 sin( 1 2 )x with eigenvalues λ = p( 1 2 )2 + q φ (x) Plug in I(v k ) = N 1 [(v k ) 2 λ 2 π fv k φ dx] Minimize: v k = π f φ dx/λ for = 1, 2,..., N Minimize: v k = π f φ dx/λ for = 1, 2,..., N Thus, u h = N 1 (f, φ )φ /λ 2 / 34 2 / 34 Example: Eigenvectors as trial functions Example: Eigenvectors as trial functions Assume p, q > are constants Assume p, q > are constants [p (v ) 2 + qv 2 2fv] dx [p (v ) 2 + qv 2 2fv] dx Choose eigenfunctions = 1, 2,..., N = 1/h φ (x) = π 2 sin( 1 2 )x with eigenvalues λ = p( 1 2 )2 + q Choose eigenfunctions = 1, 2,..., N = 1/h φ (x) = π 2 sin( 1 2 )x with eigenvalues λ = p( 1 2 )2 + q φ (x) φ (x) Plug in I(v k ) = N 1 [(v k ) 2 λ 2 π fv k φ dx] Plug in I(v k ) = N 1 [(v k ) 2 λ 2 π fv k φ dx] Minimize: v k = π f φ dx/λ for = 1, 2,..., N Minimize: v k = π f φ dx/λ for = 1, 2,..., N Thus, u h = N 1 (f, φ )φ /λ These are proections of true solution u = 1 (f, φ )φ /λ Thus, u h = N 1 (f, φ )φ /λ These are proections of true solution u = 1 (f, φ )φ /λ Converges as f /λ f / 2. 2 / 34 2 / 34

8 Example: Polynomials as trial functions Assume p, q > are constants Choose v k (x) = N =1 v k x v k () = I(v k ) = π [p( v k x 1 ) 2 + q( v k x ) 2 2f v k x ] dx Differentiating I w.r.t. v k gives N N system KV = F Topics where K i = piπi+ 1 i+ 1 + qπi++1 i++1 and F = π fx dx K is like the Hilbert matrix, very bad for n>12 Can be partially fixed using orthogonal polynomials 21 / / 34 FEM Stiffness matrix Strang and Fix discuss FEM in terms of minimization form Customary today to use stationary form a(u, v) = π [p u v + q uv] dx (f, v) = π fv dx Find u HE 1(, π) so that a(u, v) = (f, v) for all v H1 (, π). Choose a finite-dimensional subspace S h HE 1 (, π) Find u h S h so that a(u h, v h ) = (f, v h ) for all v h S h. Functions v h are called test functions. Let {φ } N =1 be a basis of Sh u h (x) = n =1 uh φ (x) For each φ i, a(u h, φ i ) = π = [p u h φ φ i + q u h φ φ i ] dx ( π = K i u h = KU h pφ i φ + qφ i φ )u h dx K is the stiffness matrix 23 / / 34

9 FEM: Piecewise linear functions Divide the interval [, π] into N subintervals, each of length h = π/n using N + 1 points x = ( 1)h for = 1,..., N + 1 Construct N hat functions φ φ (x i ) = δ i Piecewise linear φ () = At most 2 φ are nonzero on any element. φ (x) 1 Assembling the system Take p = q = 1 Elementwise computation, for e l = [x l 1, x l ] π Ki h = φ i φ + φ i φ dx = φ i φ + φ i φ dx l e l (f, φ i ) = b i = φ i f (x) dx l e l System becomes K h U h = b h ( 1)h ( +1)h π 25 / / 34 First part: κ 1 = e l φ i φ More terms For each element, there is a Left endpoint and a Right endpoint e φ Lφ L = 1 h e φ Lφ R = 1 h e φ Rφ L = 1 h e φ Rφ R = 1 h For the first element, there is only a right endpoint (h)(κ 1 ) = (κ 1 ) = h The second stiffness term is similar 4 1 (κ 2 ) = h If f is given by its nodal values f i = f (x i ) then b = κ 2 f i. 27 / / 34

10 Integration Topics In more complicated situations, it is better to compute the integrals using Gauß integration. This involves a weighted sum over a few points inside the element. 29 / 34 3 / 34 Error and convergence Theorem Suppose that u minimizes I(v) over the full admissible space H 1 E, and S h is any closed subspace of H 1 E. Then: 1. The minimun of I(v h ) and the minimum of a(u v h, u v h ), as v h ranges over the subspace S h, are achieved by the same function u h. Therefore a(u u h, u u h ) = min v h S ha(u v h, u v h ) 2. With respect to the energy inner product, u h is the proection of u onto S h. Equivalently, the error u u h is orthogonal to S h : a(u u h, v h ) = 3. The minimizing function satisfies a(u h, v h ) = (f, v h ) v h S h v h S h 4. In particular, if S h is the whole space H 1 E, then First error estimate (Cea) a(u u h, v) = (f, v) (f, v) = a(u u h, u u h ) = a(u u h, u v) + a(u u h, v u h ) Since u u h is not in S h, Since p(x) p >, So that a(u u h, u u h ) = a(u u h, u v) p u u h 2 1 ( p + q ) u u h 1 u v 1 u u h 1 p + q p u v 1 (Cea) Choose v to be the linear interpolant of u, so, from Taylor s theorem (integral form) u u h 1 Ch u 2 a(u, v) = (f, v) v H 1 E 31 / / 34

11 Second error estimate (Nitsche) Error estimate steps Let w and w h be the true and approximate solutions of a(w, v) = (u u h, v) Clearly, u u h 2 = a(w, u u h ) And a(u u h, w h ) = So u u h 2 = a(u u h, w w h ) By Cauchy-Schwarz, u u h 2 a(u u h, u u h ) a(w w h, w w h ) 1. Cea tells us the error u u h 1 is smaller than the best approximation error 2. Choice of element tells us approximation error is O(h) in 1 3. Nitsche tells us to error is O(h 2 ) in These results are generally true! Applying first estimate, u u h 2 C 2 h 2 u 2 w 2 From definition of w, w 2 C u u h Finally, u u h Ch 2 u 2 33 / / 34

1 Discretizing BVP with Finite Element Methods.

1 Discretizing BVP with Finite Element Methods. 1 Discretizing BVP with Finite Element Methods In this section, we will discuss a process for solving boundary value problems numerically, the Finite Element Method (FEM) We note that such method is a

More information

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

Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials Platzhalter für Bild, Bild auf Titelfolie hinter das Logo einsetzen Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials Dr. Noemi Friedman Contents of the course Fundamentals

More information

Chapter 1: The Finite Element Method

Chapter 1: The Finite Element Method Chapter 1: The Finite Element Method Michael Hanke Read: Strang, p 428 436 A Model Problem Mathematical Models, Analysis and Simulation, Part Applications: u = fx), < x < 1 u) = u1) = D) axial deformation

More information

Finite Element Method for Ordinary Differential Equations

Finite Element Method for Ordinary Differential Equations 52 Chapter 4 Finite Element Method for Ordinary Differential Equations In this chapter we consider some simple examples of the finite element method for the approximate solution of ordinary differential

More information

Functional Analysis Review

Functional Analysis Review Outline 9.520: Statistical Learning Theory and Applications February 8, 2010 Outline 1 2 3 4 Vector Space Outline A vector space is a set V with binary operations +: V V V and : R V V such that for all

More information

A very short introduction to the Finite Element Method

A very short introduction to the Finite Element Method A very short introduction to the Finite Element Method Till Mathis Wagner Technical University of Munich JASS 2004, St Petersburg May 4, 2004 1 Introduction This is a short introduction to the finite element

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Variational Problems of the Dirichlet BVP of the Poisson Equation 1 For the homogeneous

More information

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

1. Let a(x) > 0, and assume that u and u h are the solutions of the Dirichlet problem: Mathematics Chalmers & GU TMA37/MMG800: Partial Differential Equations, 011 08 4; kl 8.30-13.30. Telephone: Ida Säfström: 0703-088304 Calculators, formula notes and other subject related material are not

More information

Your first day at work MATH 806 (Fall 2015)

Your first day at work MATH 806 (Fall 2015) Your first day at work MATH 806 (Fall 2015) 1. Let X be a set (with no particular algebraic structure). A function d : X X R is called a metric on X (and then X is called a metric space) when d satisfies

More information

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

Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials Platzhalter für Bild, Bild auf Titelfolie hinter das Logo einsetzen Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials Dr. Noemi Friedman Contents of the course Fundamentals

More information

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

FEniCS Course. Lecture 0: Introduction to FEM. Contributors Anders Logg, Kent-Andre Mardal FEniCS Course Lecture 0: Introduction to FEM Contributors Anders Logg, Kent-Andre Mardal 1 / 46 What is FEM? The finite element method is a framework and a recipe for discretization of mathematical problems

More information

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

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1 Scientific Computing WS 2017/2018 Lecture 18 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 18 Slide 1 Lecture 18 Slide 2 Weak formulation of homogeneous Dirichlet problem Search u H0 1 (Ω) (here,

More information

Chapter 1 Foundations of Elliptic Boundary Value Problems 1.1 Euler equations of variational problems

Chapter 1 Foundations of Elliptic Boundary Value Problems 1.1 Euler equations of variational problems Chapter 1 Foundations of Elliptic Boundary Value Problems 1.1 Euler equations of variational problems Elliptic boundary value problems often occur as the Euler equations of variational problems the latter

More information

v(x, 0) = g(x) where g(x) = f(x) U(x). The solution is where b n = 2 g(x) sin(nπx) dx. (c) As t, we have v(x, t) 0 and u(x, t) U(x).

v(x, 0) = g(x) where g(x) = f(x) U(x). The solution is where b n = 2 g(x) sin(nπx) dx. (c) As t, we have v(x, t) 0 and u(x, t) U(x). Problem set 4: Solutions Math 27B, Winter216 1. The following nonhomogeneous IBVP describes heat flow in a rod whose ends are held at temperatures u, u 1 : u t = u xx < x < 1, t > u(, t) = u, u(1, t) =

More information

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

Scientific Computing WS 2018/2019. Lecture 15. Jürgen Fuhrmann Lecture 15 Slide 1 Scientific Computing WS 2018/2019 Lecture 15 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 15 Slide 1 Lecture 15 Slide 2 Problems with strong formulation Writing the PDE with divergence and gradient

More information

Mathematical Modeling using Partial Differential Equations (PDE s)

Mathematical Modeling using Partial Differential Equations (PDE s) Mathematical Modeling using Partial Differential Equations (PDE s) 145. Physical Models: heat conduction, vibration. 146. Mathematical Models: why build them. The solution to the mathematical model will

More information

Applied Linear Algebra in Geoscience Using MATLAB

Applied Linear Algebra in Geoscience Using MATLAB Applied Linear Algebra in Geoscience Using MATLAB Contents Getting Started Creating Arrays Mathematical Operations with Arrays Using Script Files and Managing Data Two-Dimensional Plots Programming in

More information

MATH 304 Linear Algebra Lecture 34: Review for Test 2.

MATH 304 Linear Algebra Lecture 34: Review for Test 2. MATH 304 Linear Algebra Lecture 34: Review for Test 2. Topics for Test 2 Linear transformations (Leon 4.1 4.3) Matrix transformations Matrix of a linear mapping Similar matrices Orthogonality (Leon 5.1

More information

Finite-dimensional spaces. C n is the space of n-tuples x = (x 1,..., x n ) of complex numbers. It is a Hilbert space with the inner product

Finite-dimensional spaces. C n is the space of n-tuples x = (x 1,..., x n ) of complex numbers. It is a Hilbert space with the inner product Chapter 4 Hilbert Spaces 4.1 Inner Product Spaces Inner Product Space. A complex vector space E is called an inner product space (or a pre-hilbert space, or a unitary space) if there is a mapping (, )

More information

An introduction to the mathematical theory of finite elements

An introduction to the mathematical theory of finite elements Master in Seismic Engineering E.T.S.I. Industriales (U.P.M.) Discretization Methods in Engineering An introduction to the mathematical theory of finite elements Ignacio Romero ignacio.romero@upm.es October

More information

Ordinary Differential Equations II

Ordinary Differential Equations II Ordinary Differential Equations II February 23 2017 Separation of variables Wave eq. (PDE) 2 u t (t, x) = 2 u 2 c2 (t, x), x2 c > 0 constant. Describes small vibrations in a homogeneous string. u(t, x)

More information

From Completing the Squares and Orthogonal Projection to Finite Element Methods

From Completing the Squares and Orthogonal Projection to Finite Element Methods From Completing the Squares and Orthogonal Projection to Finite Element Methods Mo MU Background In scientific computing, it is important to start with an appropriate model in order to design effective

More information

Finite-Elements Method 2

Finite-Elements Method 2 Finite-Elements Method 2 January 29, 2014 2 From Applied Numerical Analysis Gerald-Wheatley (2004), Chapter 9. Finite-Elements Method 3 Introduction Finite-element methods (FEM) are based on some mathematical

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods The Connection to Green s Kernels Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2014 fasshauer@iit.edu MATH 590 1 Outline 1 Introduction

More information

LECTURE 1: SOURCES OF ERRORS MATHEMATICAL TOOLS A PRIORI ERROR ESTIMATES. Sergey Korotov,

LECTURE 1: SOURCES OF ERRORS MATHEMATICAL TOOLS A PRIORI ERROR ESTIMATES. Sergey Korotov, LECTURE 1: SOURCES OF ERRORS MATHEMATICAL TOOLS A PRIORI ERROR ESTIMATES Sergey Korotov, Institute of Mathematics Helsinki University of Technology, Finland Academy of Finland 1 Main Problem in Mathematical

More information

Finite Difference and Finite Element Methods

Finite Difference and Finite Element Methods Finite Difference and Finite Element Methods Georgy Gimel farb COMPSCI 369 Computational Science 1 / 39 1 Finite Differences Difference Equations 3 Finite Difference Methods: Euler FDMs 4 Finite Element

More information

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

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) RAYTCHO LAZAROV 1 Notations and Basic Functional Spaces Scalar function in R d, d 1 will be denoted by u,

More information

SPECTRAL PROPERTIES OF THE LAPLACIAN ON BOUNDED DOMAINS

SPECTRAL PROPERTIES OF THE LAPLACIAN ON BOUNDED DOMAINS SPECTRAL PROPERTIES OF THE LAPLACIAN ON BOUNDED DOMAINS TSOGTGEREL GANTUMUR Abstract. After establishing discrete spectra for a large class of elliptic operators, we present some fundamental spectral properties

More information

Applied/Numerical Analysis Qualifying Exam

Applied/Numerical Analysis Qualifying Exam Applied/Numerical Analysis Qualifying Exam August 9, 212 Cover Sheet Applied Analysis Part Policy on misprints: The qualifying exam committee tries to proofread exams as carefully as possible. Nevertheless,

More information

j=1 [We will show that the triangle inequality holds for each p-norm in Chapter 3 Section 6.] The 1-norm is A F = tr(a H A).

j=1 [We will show that the triangle inequality holds for each p-norm in Chapter 3 Section 6.] The 1-norm is A F = tr(a H A). Math 344 Lecture #19 3.5 Normed Linear Spaces Definition 3.5.1. A seminorm on a vector space V over F is a map : V R that for all x, y V and for all α F satisfies (i) x 0 (positivity), (ii) αx = α x (scale

More information

Applied Analysis (APPM 5440): Final exam 1:30pm 4:00pm, Dec. 14, Closed books.

Applied Analysis (APPM 5440): Final exam 1:30pm 4:00pm, Dec. 14, Closed books. Applied Analysis APPM 44: Final exam 1:3pm 4:pm, Dec. 14, 29. Closed books. Problem 1: 2p Set I = [, 1]. Prove that there is a continuous function u on I such that 1 ux 1 x sin ut 2 dt = cosx, x I. Define

More information

MATH 304 Linear Algebra Lecture 20: The Gram-Schmidt process (continued). Eigenvalues and eigenvectors.

MATH 304 Linear Algebra Lecture 20: The Gram-Schmidt process (continued). Eigenvalues and eigenvectors. MATH 304 Linear Algebra Lecture 20: The Gram-Schmidt process (continued). Eigenvalues and eigenvectors. Orthogonal sets Let V be a vector space with an inner product. Definition. Nonzero vectors v 1,v

More information

(L, t) = 0, t > 0. (iii)

(L, t) = 0, t > 0. (iii) . Sturm Liouville Boundary Value Problems 69 where E is Young s modulus and ρ is the mass per unit volume. If the end x = isfixed, then the boundary condition there is u(, t) =, t >. (ii) Suppose that

More information

Some definitions. Math 1080: Numerical Linear Algebra Chapter 5, Solving Ax = b by Optimization. A-inner product. Important facts

Some definitions. Math 1080: Numerical Linear Algebra Chapter 5, Solving Ax = b by Optimization. A-inner product. Important facts Some definitions Math 1080: Numerical Linear Algebra Chapter 5, Solving Ax = b by Optimization M. M. Sussman sussmanm@math.pitt.edu Office Hours: MW 1:45PM-2:45PM, Thack 622 A matrix A is SPD (Symmetric

More information

1. General Vector Spaces

1. General Vector Spaces 1.1. Vector space axioms. 1. General Vector Spaces Definition 1.1. Let V be a nonempty set of objects on which the operations of addition and scalar multiplication are defined. By addition we mean a rule

More information

Math 1080: Numerical Linear Algebra Chapter 4, Iterative Methods

Math 1080: Numerical Linear Algebra Chapter 4, Iterative Methods Math 1080: Numerical Linear Algebra Chapter 4, Iterative Methods M. M. Sussman sussmanm@math.pitt.edu Office Hours: MW 1:45PM-2:45PM, Thack 622 March 2015 1 / 70 Topics Introduction to Iterative Methods

More information

Finite Element Methods

Finite Element Methods Solving Operator Equations Via Minimization We start with several definitions. Definition. Let V be an inner product space. A linear operator L: D V V is said to be positive definite if v, Lv > for every

More information

Boundary Value Problems and Iterative Methods for Linear Systems

Boundary Value Problems and Iterative Methods for Linear Systems Boundary Value Problems and Iterative Methods for Linear Systems 1. Equilibrium Problems 1.1. Abstract setting We want to find a displacement u V. Here V is a complete vector space with a norm v V. In

More information

Introduction to Finite Element Method

Introduction to Finite Element Method Introduction to Finite Element Method Dr. Rakesh K Kapania Aerospace and Ocean Engineering Department Virginia Polytechnic Institute and State University, Blacksburg, VA AOE 524, Vehicle Structures Summer,

More information

Inner products. Theorem (basic properties): Given vectors u, v, w in an inner product space V, and a scalar k, the following properties hold:

Inner products. Theorem (basic properties): Given vectors u, v, w in an inner product space V, and a scalar k, the following properties hold: Inner products Definition: An inner product on a real vector space V is an operation (function) that assigns to each pair of vectors ( u, v) in V a scalar u, v satisfying the following axioms: 1. u, v

More information

Chapter 3 Conforming Finite Element Methods 3.1 Foundations Ritz-Galerkin Method

Chapter 3 Conforming Finite Element Methods 3.1 Foundations Ritz-Galerkin Method Chapter 3 Conforming Finite Element Methods 3.1 Foundations 3.1.1 Ritz-Galerkin Method Let V be a Hilbert space, a(, ) : V V lr a bounded, V-elliptic bilinear form and l : V lr a bounded linear functional.

More information

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

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs Chapter Two: Numerical Methods for Elliptic PDEs Finite Difference Methods for Elliptic PDEs.. Finite difference scheme. We consider a simple example u := subject to Dirichlet boundary conditions ( ) u

More information

AMS 212A Applied Mathematical Methods I Appendices of Lecture 06 Copyright by Hongyun Wang, UCSC. ( ) cos2

AMS 212A Applied Mathematical Methods I Appendices of Lecture 06 Copyright by Hongyun Wang, UCSC. ( ) cos2 AMS 22A Applied Mathematical Methods I Appendices of Lecture 06 Copyright by Hongyun Wang UCSC Appendix A: Proof of Lemma Lemma : Let (x ) be the solution of x ( r( x)+ q( x) )sin 2 + ( a) 0 < cos2 where

More information

Linear Algebra Massoud Malek

Linear Algebra Massoud Malek CSUEB Linear Algebra Massoud Malek Inner Product and Normed Space In all that follows, the n n identity matrix is denoted by I n, the n n zero matrix by Z n, and the zero vector by θ n An inner product

More information

Lecture 20: 6.1 Inner Products

Lecture 20: 6.1 Inner Products Lecture 0: 6.1 Inner Products Wei-Ta Chu 011/1/5 Definition An inner product on a real vector space V is a function that associates a real number u, v with each pair of vectors u and v in V in such a way

More information

Math Theory of Partial Differential Equations Lecture 3-2: Spectral properties of the Laplacian. Bessel functions.

Math Theory of Partial Differential Equations Lecture 3-2: Spectral properties of the Laplacian. Bessel functions. Math 412-501 Theory of Partial ifferential Equations Lecture 3-2: Spectral properties of the Laplacian. Bessel functions. Eigenvalue problem: 2 φ + λφ = 0 in, ( αφ + β φ ) n = 0, where α, β are piecewise

More information

Math 350 Fall 2011 Notes about inner product spaces. In this notes we state and prove some important properties of inner product spaces.

Math 350 Fall 2011 Notes about inner product spaces. In this notes we state and prove some important properties of inner product spaces. Math 350 Fall 2011 Notes about inner product spaces In this notes we state and prove some important properties of inner product spaces. First, recall the dot product on R n : if x, y R n, say x = (x 1,...,

More information

The following definition is fundamental.

The following definition is fundamental. 1. Some Basics from Linear Algebra With these notes, I will try and clarify certain topics that I only quickly mention in class. First and foremost, I will assume that you are familiar with many basic

More information

Laplace s Equation FEM Methods. Jacob White. Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy, Jaime Peraire and Tony Patera

Laplace s Equation FEM Methods. Jacob White. Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy, Jaime Peraire and Tony Patera Introduction to Simulation - Lecture 19 Laplace s Equation FEM Methods Jacob White Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy, Jaime Peraire and Tony Patera Outline for Poisson Equation

More information

Introduction. Math 1080: Numerical Linear Algebra Chapter 4, Iterative Methods. Example: First Order Richardson. Strategy

Introduction. Math 1080: Numerical Linear Algebra Chapter 4, Iterative Methods. Example: First Order Richardson. Strategy Introduction Math 1080: Numerical Linear Algebra Chapter 4, Iterative Methods M. M. Sussman sussmanm@math.pitt.edu Office Hours: MW 1:45PM-2:45PM, Thack 622 Solve system Ax = b by repeatedly computing

More information

Projected Surface Finite Elements for Elliptic Equations

Projected Surface Finite Elements for Elliptic Equations Available at http://pvamu.edu/aam Appl. Appl. Math. IN: 1932-9466 Vol. 8, Issue 1 (June 2013), pp. 16 33 Applications and Applied Mathematics: An International Journal (AAM) Projected urface Finite Elements

More information

Analysis Preliminary Exam Workshop: Hilbert Spaces

Analysis Preliminary Exam Workshop: Hilbert Spaces Analysis Preliminary Exam Workshop: Hilbert Spaces 1. Hilbert spaces A Hilbert space H is a complete real or complex inner product space. Consider complex Hilbert spaces for definiteness. If (, ) : H H

More information

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

Outline. 1 Boundary Value Problems. 2 Numerical Methods for BVPs. Boundary Value Problems Numerical Methods for BVPs Boundary Value Problems Numerical Methods for BVPs Outline Boundary Value Problems 2 Numerical Methods for BVPs Michael T. Heath Scientific Computing 2 / 45 Boundary Value Problems Numerical Methods for

More information

In this worksheet we will use the eigenfunction expansion to solve nonhomogeneous equation.

In this worksheet we will use the eigenfunction expansion to solve nonhomogeneous equation. Eigen Function Expansion and Applications. In this worksheet we will use the eigenfunction expansion to solve nonhomogeneous equation. a/ The theory. b/ Example: Solving the Euler equation in two ways.

More information

Functional Analysis Review

Functional Analysis Review Functional Analysis Review Lorenzo Rosasco slides courtesy of Andre Wibisono 9.520: Statistical Learning Theory and Applications September 9, 2013 1 2 3 4 Vector Space A vector space is a set V with binary

More information

6 Inner Product Spaces

6 Inner Product Spaces Lectures 16,17,18 6 Inner Product Spaces 6.1 Basic Definition Parallelogram law, the ability to measure angle between two vectors and in particular, the concept of perpendicularity make the euclidean space

More information

MAT 578 FUNCTIONAL ANALYSIS EXERCISES

MAT 578 FUNCTIONAL ANALYSIS EXERCISES MAT 578 FUNCTIONAL ANALYSIS EXERCISES JOHN QUIGG Exercise 1. Prove that if A is bounded in a topological vector space, then for every neighborhood V of 0 there exists c > 0 such that tv A for all t > c.

More information

Simple Examples on Rectangular Domains

Simple Examples on Rectangular Domains 84 Chapter 5 Simple Examples on Rectangular Domains In this chapter we consider simple elliptic boundary value problems in rectangular domains in R 2 or R 3 ; our prototype example is the Poisson equation

More information

Math 290, Midterm II-key

Math 290, Midterm II-key Math 290, Midterm II-key Name (Print): (first) Signature: (last) The following rules apply: There are a total of 20 points on this 50 minutes exam. This contains 7 pages (including this cover page) and

More information

ANALYSIS OF THE FEM AND DGM FOR AN ELLIPTIC PROBLEM WITH A NONLINEAR NEWTON BOUNDARY CONDITION

ANALYSIS OF THE FEM AND DGM FOR AN ELLIPTIC PROBLEM WITH A NONLINEAR NEWTON BOUNDARY CONDITION Proceedings of EQUADIFF 2017 pp. 127 136 ANALYSIS OF THE FEM AND DGM FOR AN ELLIPTIC PROBLEM WITH A NONLINEAR NEWTON BOUNDARY CONDITION MILOSLAV FEISTAUER, ONDŘEJ BARTOŠ, FILIP ROSKOVEC, AND ANNA-MARGARETE

More information

Basic Calculus Review

Basic Calculus Review Basic Calculus Review Lorenzo Rosasco ISML Mod. 2 - Machine Learning Vector Spaces Functionals and Operators (Matrices) Vector Space A vector space is a set V with binary operations +: V V V and : R V

More information

MATH 304 Linear Algebra Lecture 23: Diagonalization. Review for Test 2.

MATH 304 Linear Algebra Lecture 23: Diagonalization. Review for Test 2. MATH 304 Linear Algebra Lecture 23: Diagonalization. Review for Test 2. Diagonalization Let L be a linear operator on a finite-dimensional vector space V. Then the following conditions are equivalent:

More information

Recitation 1 (Sep. 15, 2017)

Recitation 1 (Sep. 15, 2017) Lecture 1 8.321 Quantum Theory I, Fall 2017 1 Recitation 1 (Sep. 15, 2017) 1.1 Simultaneous Diagonalization In the last lecture, we discussed the situations in which two operators can be simultaneously

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Sobolev Embedding Theorems Embedding Operators and the Sobolev Embedding Theorem

More information

Iterative Methods for Linear Systems

Iterative Methods for Linear Systems Iterative Methods for Linear Systems 1. Introduction: Direct solvers versus iterative solvers In many applications we have to solve a linear system Ax = b with A R n n and b R n given. If n is large the

More information

Numerical Solution I

Numerical Solution I Numerical Solution I Stationary Flow R. Kornhuber (FU Berlin) Summerschool Modelling of mass and energy transport in porous media with practical applications October 8-12, 2018 Schedule Classical Solutions

More information

Lectures on the Finite Element Method

Lectures on the Finite Element Method Anders Logg Kent-Andre Mardal Editors Lectures on the Finite Element Method Contents 1 The finite element method 1 1.1 A simple model problem..................................... 1 1.2 Solving Poisson

More information

Definition and basic properties of heat kernels I, An introduction

Definition and basic properties of heat kernels I, An introduction Definition and basic properties of heat kernels I, An introduction Zhiqin Lu, Department of Mathematics, UC Irvine, Irvine CA 92697 April 23, 2010 In this lecture, we will answer the following questions:

More information

Vectors in Function Spaces

Vectors in Function Spaces Jim Lambers MAT 66 Spring Semester 15-16 Lecture 18 Notes These notes correspond to Section 6.3 in the text. Vectors in Function Spaces We begin with some necessary terminology. A vector space V, also

More information

A brief introduction to finite element methods

A brief introduction to finite element methods CHAPTER A brief introduction to finite element methods 1. Two-point boundary value problem and the variational formulation 1.1. The model problem. Consider the two-point boundary value problem: Given a

More information

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

Finite Elements. Colin Cotter. February 22, Colin Cotter FEM Finite Elements February 22, 2019 In the previous sections, we introduced the concept of finite element spaces, which contain certain functions defined on a domain. Finite element spaces are examples of

More information

INTRODUCTION TO FINITE ELEMENT METHODS

INTRODUCTION TO FINITE ELEMENT METHODS INTRODUCTION TO FINITE ELEMENT METHODS LONG CHEN Finite element methods are based on the variational formulation of partial differential equations which only need to compute the gradient of a function.

More information

Multigrid Methods for Saddle Point Problems

Multigrid Methods for Saddle Point Problems Multigrid Methods for Saddle Point Problems Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University Advances in Mathematics of Finite Elements (In

More information

1. Quantum Mechanics, Cohen Tannoudji, Chapters Linear Algebra, Schaum Series 3. Quantum Chemistry Ch. 6

1. Quantum Mechanics, Cohen Tannoudji, Chapters Linear Algebra, Schaum Series 3. Quantum Chemistry Ch. 6 Lecture # Today s Program 1. Recap: Classical States, Hamiltonians and time evolution. First postulate The description of a state of a system. 3. Second postulate physical quantities. 4. Linear operators.

More information

5 Compact linear operators

5 Compact linear operators 5 Compact linear operators One of the most important results of Linear Algebra is that for every selfadjoint linear map A on a finite-dimensional space, there exists a basis consisting of eigenvectors.

More information

Numerical Methods for Two Point Boundary Value Problems

Numerical Methods for Two Point Boundary Value Problems Numerical Methods for Two Point Boundary Value Problems Graeme Fairweather and Ian Gladwell 1 Finite Difference Methods 1.1 Introduction Consider the second order linear two point boundary value problem

More information

1. What is the determinant of the following matrix? a 1 a 2 4a 3 2a 2 b 1 b 2 4b 3 2b c 1. = 4, then det

1. What is the determinant of the following matrix? a 1 a 2 4a 3 2a 2 b 1 b 2 4b 3 2b c 1. = 4, then det What is the determinant of the following matrix? 3 4 3 4 3 4 4 3 A 0 B 8 C 55 D 0 E 60 If det a a a 3 b b b 3 c c c 3 = 4, then det a a 4a 3 a b b 4b 3 b c c c 3 c = A 8 B 6 C 4 D E 3 Let A be an n n matrix

More information

Math 5520 Homework 2 Solutions

Math 5520 Homework 2 Solutions Math 552 Homework 2 Solutions March, 26. Consider the function fx) = 2x ) 3 if x, 3x ) 2 if < x 2. Determine for which k there holds f H k, 2). Find D α f for α k. Solution. We show that k = 2. The formulas

More information

Linear Algebra. Session 12

Linear Algebra. Session 12 Linear Algebra. Session 12 Dr. Marco A Roque Sol 08/01/2017 Example 12.1 Find the constant function that is the least squares fit to the following data x 0 1 2 3 f(x) 1 0 1 2 Solution c = 1 c = 0 f (x)

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 2 Part 3: Native Space for Positive Definite Kernels Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2014 fasshauer@iit.edu MATH

More information

THE PROBLEMS FOR THE SECOND TEST FOR BRIEF SOLUTIONS

THE PROBLEMS FOR THE SECOND TEST FOR BRIEF SOLUTIONS THE PROBLEMS FOR THE SECOND TEST FOR 18.102 BRIEF SOLUTIONS RICHARD MELROSE Question.1 Show that a subset of a separable Hilbert space is compact if and only if it is closed and bounded and has the property

More information

Sobolevology. 1. Definitions and Notation. When α = 1 this seminorm is the same as the Lipschitz constant of the function f. 2.

Sobolevology. 1. Definitions and Notation. When α = 1 this seminorm is the same as the Lipschitz constant of the function f. 2. Sobolevology 1. Definitions and Notation 1.1. The domain. is an open subset of R n. 1.2. Hölder seminorm. For α (, 1] the Hölder seminorm of exponent α of a function is given by f(x) f(y) [f] α = sup x

More information

Numerical Methods for Partial Differential Equations

Numerical Methods for Partial Differential Equations Numerical Methods for Partial Differential Equations Eric de Sturler University of Illinois at Urbana-Champaign Read section 8. to see where equations of type (au x ) x = f show up and their (exact) solution

More information

NEW A PRIORI FEM ERROR ESTIMATES FOR EIGENVALUES

NEW A PRIORI FEM ERROR ESTIMATES FOR EIGENVALUES NEW A PRIORI FEM ERROR ESTIMATES FOR EIGENVALUES ANDREW V. KNYAZEV AND JOHN E. OSBORN Abstract. We analyze the Ritz method for symmetric eigenvalue problems and prove a priori eigenvalue error estimates.

More information

Math 413/513 Chapter 6 (from Friedberg, Insel, & Spence)

Math 413/513 Chapter 6 (from Friedberg, Insel, & Spence) Math 413/513 Chapter 6 (from Friedberg, Insel, & Spence) David Glickenstein December 7, 2015 1 Inner product spaces In this chapter, we will only consider the elds R and C. De nition 1 Let V be a vector

More information

PART IV Spectral Methods

PART IV Spectral Methods PART IV Spectral Methods Additional References: R. Peyret, Spectral methods for incompressible viscous flow, Springer (2002), B. Mercier, An introduction to the numerical analysis of spectral methods,

More information

Lecture 10: Fourier Sine Series

Lecture 10: Fourier Sine Series Introductory lecture notes on Partial Differential Equations - c Anthony Peirce. Not to be copied, used, or revised without eplicit written permission from the copyright owner. ecture : Fourier Sine Series

More information

Solution of Non-Homogeneous Dirichlet Problems with FEM

Solution of Non-Homogeneous Dirichlet Problems with FEM Master Thesis Solution of Non-Homogeneous Dirichlet Problems with FEM Francesco Züger Institut für Mathematik Written under the supervision of Prof. Dr. Stefan Sauter and Dr. Alexander Veit August 27,

More information

Lecture 1: Review of linear algebra

Lecture 1: Review of linear algebra Lecture 1: Review of linear algebra Linear functions and linearization Inverse matrix, least-squares and least-norm solutions Subspaces, basis, and dimension Change of basis and similarity transformations

More information

Math Real Analysis II

Math Real Analysis II Math 4 - Real Analysis II Solutions to Homework due May Recall that a function f is called even if f( x) = f(x) and called odd if f( x) = f(x) for all x. We saw that these classes of functions had a particularly

More information

Applied Linear Algebra in Geoscience Using MATLAB

Applied Linear Algebra in Geoscience Using MATLAB Applied Linear Algebra in Geoscience Using MATLAB Contents Getting Started Creating Arrays Mathematical Operations with Arrays Using Script Files and Managing Data Two-Dimensional Plots Programming in

More information

Variational Formulations

Variational Formulations Chapter 2 Variational Formulations In this chapter we will derive a variational (or weak) formulation of the elliptic boundary value problem (1.4). We will discuss all fundamental theoretical results that

More information

Algebra II. Paulius Drungilas and Jonas Jankauskas

Algebra II. Paulius Drungilas and Jonas Jankauskas Algebra II Paulius Drungilas and Jonas Jankauskas Contents 1. Quadratic forms 3 What is quadratic form? 3 Change of variables. 3 Equivalence of quadratic forms. 4 Canonical form. 4 Normal form. 7 Positive

More information

Hilbert Spaces: Infinite-Dimensional Vector Spaces

Hilbert Spaces: Infinite-Dimensional Vector Spaces Hilbert Spaces: Infinite-Dimensional Vector Spaces PHYS 500 - Southern Illinois University October 27, 2016 PHYS 500 - Southern Illinois University Hilbert Spaces: Infinite-Dimensional Vector Spaces October

More information

arxiv: v1 [math.na] 1 May 2013

arxiv: v1 [math.na] 1 May 2013 arxiv:3050089v [mathna] May 03 Approximation Properties of a Gradient Recovery Operator Using a Biorthogonal System Bishnu P Lamichhane and Adam McNeilly May, 03 Abstract A gradient recovery operator based

More information

Exercises * on Linear Algebra

Exercises * on Linear Algebra Exercises * on Linear Algebra Laurenz Wiskott Institut für Neuroinformatik Ruhr-Universität Bochum, Germany, EU 4 February 7 Contents Vector spaces 4. Definition...............................................

More information

Class notes: Approximation

Class notes: Approximation Class notes: Approximation Introduction Vector spaces, linear independence, subspace The goal of Numerical Analysis is to compute approximations We want to approximate eg numbers in R or C vectors in R

More information

Math Tune-Up Louisiana State University August, Lectures on Partial Differential Equations and Hilbert Space

Math Tune-Up Louisiana State University August, Lectures on Partial Differential Equations and Hilbert Space Math Tune-Up Louisiana State University August, 2008 Lectures on Partial Differential Equations and Hilbert Space 1. A linear partial differential equation of physics We begin by considering the simplest

More information

Preliminary Examination, Numerical Analysis, August 2016

Preliminary Examination, Numerical Analysis, August 2016 Preliminary Examination, Numerical Analysis, August 2016 Instructions: This exam is closed books and notes. The time allowed is three hours and you need to work on any three out of questions 1-4 and any

More information

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

ACM/CMS 107 Linear Analysis & Applications Fall 2017 Assignment 2: PDEs and Finite Element Methods Due: 7th November 2017 ACM/CMS 17 Linear Analysis & Applications Fall 217 Assignment 2: PDEs and Finite Element Methods Due: 7th November 217 For this assignment the following MATLAB code will be required: Introduction http://wwwmdunloporg/cms17/assignment2zip

More information