Numerical Solutions to Differential Equations

Size: px
Start display at page:

Download "Numerical Solutions to Differential Equations"

Transcription

1 Numerical Solutions to Differential Equations Lecture Notes The Finite Element Method #2 Peter Blomgren, Department of Mathematics and Statistics Dynamical Systems Group Computational Sciences Research Center San Diego State University San Diego, CA Spring 2015 Peter Blomgren, Numerical Solutions to Differential Equations (1/24)

2 Outline 1 The Finite Element Method Recap Looking for Solutions... 2 Identifying a Linear System... Properties of the Stiffness Matrix 3 Building the Toolbox Error Control 4 Initial Example: The Poisson Equation Analytical Tools: Vector Calculus Variational Formulation Minimization Formulation The Road Ahead... Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (2/24)

3 Recap Looking for Solutions... Quick Recap I/III Last time we formulated the Galerkin (variational, (V h )) and Ritz (minimization, (M h )) methods which will give us the finite element solutions to the differential equation (D): u = f, + Dirichlet Boundary Conditions The Function Space V h : Given the basis functions φ i (the tent functions) we can write V h = { v : v = } N η i φ i (x). i=1 Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (3/24)

4 Recap Looking for Solutions... Quick Recap II/III Inner Products: We defined the two (for now identical) inner products: a(u,v) = I uv dx, (u,v) = Further, we defined the energy functional: F(u) = 1 2 a(v,v ) (f,v). I uv dx. Given these definitions we formulated the Galerkin and Ritz problems... Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (4/24)

5 Recap Looking for Solutions... Quick Recap III/III Galerkin s Method (Variational Approach) (V h ) Find u h V h so that a(u h,v h ) = (f,v h) v h V h. Ritz Method (Minimization Approach) (M h ) Find u h V h so that F(u h ) F(v h ) v h V h. Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (5/24)

6 Recap Looking for Solutions... Looking for the Solution... If u h V h is a solution to (V h ), then in particular a(u h,φ j) = (f,φ j ), j = 1,2,...,N. Also, we can write u h in terms of the basis functions: u h (x) = N ξ j φ j (x), ξ j = u h (x j ). j=1 Therefore we can rewrite the above equation N ξ i a(φ i,φ j) = (f,φ j ), j = 1,2,...,N. i=1 Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (6/24)

7 Identifying a Linear System... Properties of the Stiffness Matrix The Stiffness Matrix and Load Vector From N ξ i a(φ i,φ j) = (f,φ j ), j = 1,2,...,N i=1 we identify the vectors ξ = {ξ 1,ξ 2,...,ξ N } T, and b = {b 1,b 2,...,b N } T, where b i = (f,φ i ), and the matrix A, where A ij = a(φ i,φ j ). We can now write our problem as A ξ = b. For historical reasons (Structural Mechanics) A is known as the stiffness matrix, and b as the load vector. Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (7/24)

8 Identifying a Linear System... Properties of the Stiffness Matrix Computing the Stiffness Matrix The elements of the stiffness matrix can be computed: First we notice that if the basis is the piecewise linear tent-functions, then if i j > 1, then φ i and φ j are non-overlapping which means a(φ i,φ j ) = 0. The Diagonal Entries, j = 1,2,...,N. a(φ j,φ j) = xj x j 1 1 h 2 j dx + xj+1 1 x j hj+1 2 dx = h j h j+1 The Super- and Sub-Diagonal Entries, j = 2,3,...,N. a(φ j 1,φ j) = a(φ j,φ j 1) = xj x j 1 1 h j 1 h j dx = 1 h j Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (8/24)

9 Identifying a Linear System... Properties of the Stiffness Matrix Illustration: Overlapping and Nonoverlapping Tent-Functions Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (9/24)

10 Identifying a Linear System... Properties of the Stiffness Matrix The Stiffness Matrix is Symmetric Positive Definite (SPD) A is symmetric since a(u,v) = a(v,u), and with v(x) = N i=1 η jφ i (x) we get N N N η i a(φ i,φ j)η j = a η i φ i, η j φ j = i,j=1 i=1 j=1 I [v h (x)]2 dx 0 Equality holds if and only if v (x) 0, which implies v(x) 0 by the boundary conditions. Fact: A matrix A is SPD if x T Ax > 0, x R n \{0} Fact: An SPD matrix (i) has positive eigenvalues, (ii) is nonsingular. Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (10/24)

11 Identifying a Linear System... Properties of the Stiffness Matrix The Special Case h j = h, j = 1,2,...,N If we equi-partition the interval we get the linear system h ξ = If we divide by h the we recover the standard finite difference method for the problem, where the right hand-side b j = xj+1 x j 1 f(x)φ j dx is a weighted mean of f(x) over the interval [x j 1,x j+1 ]. Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (11/24) b 1 b 2... b N

12 Building the Toolbox Error Control Estimating the Error for the Model Problem We are now going to look at the error (u u h ) where u is the exact solution of the differential equation, and u h is the solution to the finite element problem (V h ). Since V h V, a(u,v h ) = (f,v h), v h V h a(u h,v h ) = (f,v h), v h V h a((u u h ),v h ) = 0, v h V h That means that the error is orthogonal to the function space V h (as measured by a(, ).) Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (12/24)

13 Building the Toolbox Error Control Definition and Tools Definition (The L 2 -norm (L 2,a?)) w 2 = a(w,w) = 1 0 w 2 dx Theorem (Cauchy s Inequality) a(v,w) v w Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (13/24)

14 Building the Toolbox Error Control Cauchy s Inequality: Proof Cauchy s Inequality. Given v and w, define the renormalized functions v = v v and ŵ = w w. Which means v = ŵ = 1. Now Hence, 0 ± v ŵ 2 = a(± v ŵ,± v ŵ) = a( v, v) 2a( v,ŵ)+a(ŵ,ŵ) = 2 2a( v,ŵ). a( v,ŵ) 1. Removing the linear normalization factors give a(v,w) v w. Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (14/24)

15 Building the Toolbox Error Control Error Control Theorem Theorem For any v h V h we have (u u h ) (u v h ). So, measured in the L 2 -norm of the derivative (also known as the H 1 -seminorm), the solution u h to the discrete problem is closer to the solution u to the original continuous ODE than any other function in the function space V h. Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (15/24)

16 Building the Toolbox Error Control Error Control Proof Proof. Let v h V h be arbitrary, and set w h = u h v h. Then w h V h and we get: (u u h ) 2 = a((u u h ),(u u h ) )+a((u u h ),w h) }{{} =0 = a((u u h ),(u u h +w h ) ) = a((u u h ),(u v h ) ) {Cauchy s} (u u h ) (u v h ). Dividing through by (u u h ) gives (u u h ) (u v h ). Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (16/24)

17 Building the Toolbox Error Control Error Control Applying the Theorem From the theorem we can get a quantitative estimate (upper bound) for the error (u u h ) by estimating (u v h ) where v h V h is a suitably chosen function. Let v h be the linear interpolant of u, i.e. v h (x j ) = u(x j ), then u (x) v h (x) hmax x [0,1] u (x) [1] u(x) v h (x) h2 8 max x [0,1] u (x) [2] The first result and the theorem gives Similarly, from [2], we can get (u u h ) C 1 h max x [0,1] u (x). u(x) u h (x) C 2 h 2 max x [0,1] u (x). Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (17/24)

18 Initial Example: The Poisson Equation Analytical Tools: Vector Calculus Variational Formulation Minimization Formulation The Road Ahead... FEM for PDEs the Poisson Equation Consider the following boundary value problem u = f u = 0 in Ω on Γ = Ω, where Ω is a bounded domain in R 2 = {(x 1,x 2 ) : x 1 R,x 2 R}. Γ is the boundary of Ω, f(x 1,x 2 ) a given function, and [ 2 u = x 2 1 ] + 2 x2 2 u(x 1,x 2 ) = u x1 x 1 (x 1,x 2 )+u x2 x 2 (x 1,x 2 ). Physical problems: Our simple 1-D model problems from last lecture carry over to this 2-D model: heat distribution in a plate, the displacement of an elastic membrane fixed at the boundary under transverse load, etc... Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (18/24)

19 Initial Example: The Poisson Equation Analytical Tools: Vector Calculus Variational Formulation Minimization Formulation The Road Ahead... Vector Calculus Review (or Crash Course) I/III We need to generalize integration by parts to higher dimensions... We start with the divergence theorem: ũd x = ũ ñds, Ω where ũ = {u 1,u 2 } T, and ũ = u 1 x 1 + u 2 x 2. ñ = {n 1,n 2 } T is the unit (length-one, outward) normal to Γ. d x denotes area-integration, and ds integration along the boundary. c.f. in 1-D: du [a,b] dx dx = u( 1)ds = u(a)+u(b) {a,b} Γ Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (19/24)

20 Initial Example: The Poisson Equation Analytical Tools: Vector Calculus Variational Formulation Minimization Formulation The Road Ahead... Vector Calculus Review (or Crash Course) II/III If we apply the divergence theorem to the vector functions ũ 1 = (vw,0) and ũ 2 = (0,vw), we find v w +v w d x = vwn i ds, i = 1,2. x i x i Ω Let v denote the gradient v = Γ { v, v } T, x 1 x 2 and use the result above to write Green s Formula Ω v w d x [ ] v w Ω x 1 x 1 + v w x 2 x 2 d x = [ ] Γ v w x 1 n 1 +v w x 2 n 2 ds [ Ω v 2 w x1 2 = Γ v w n ds Ωv w d x. ] + 2 w d x x2 2 Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (20/24)

21 Initial Example: The Poisson Equation Analytical Tools: Vector Calculus Variational Formulation Minimization Formulation The Road Ahead... Vector Calculus Review (or Crash Course) III/III The normal derivative w n = w n 1 + w n 2 = w ñ x 1 x 2 is the derivative in the outward normal direction to the boundary Γ. With this notation we are ready to state the variational formulation corresponding to the differential equation... Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (21/24)

22 Initial Example: The Poisson Equation Analytical Tools: Vector Calculus Variational Formulation Minimization Formulation The Road Ahead... Variational Formulation where (V) Find u V so that a(u,v) = (f,v), v V. V = a(u,v) = Ω (f,v) = u v d x Ω fv d x v : v C(Ω) v x1 and v x2 are piecewise continuous in Ω v = 0 on Γ Note: We have slightly changed the notation of the a(, ) inner-product. This is very common in the PDE framework. The a(, ) innerproduct generically involves integrating the product(s) of derivative(s) of the two arguments over the domain. Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (22/24)

23 Initial Example: The Poisson Equation Analytical Tools: Vector Calculus Variational Formulation Minimization Formulation The Road Ahead... Minimization Formulation u is a solution to (V) if and only if it is also a solution to the following minimization problem. (M) Find u V such that F(u) F(v) v V, where F(v) is the potential energy F(v) = 1 2 a(v,v) (f,v). Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (23/24)

24 Initial Example: The Poisson Equation Analytical Tools: Vector Calculus Variational Formulation Minimization Formulation The Road Ahead... Next... Constructing a Finite Element Method for this problem... Peter Blomgren, blomgren.peter@gmail.com Numerical Solutions to Differential Equations (24/24)

Introduction to the Finite Element Method

Introduction to the Finite Element Method Introduction to the Finite Element Method 09.06.2009 Outline Motivation Partial Differential Equations (PDEs) Finite Difference Method (FDM) Finite Element Method (FEM) References Motivation Figure: cross

More information

Høgskolen i Narvik Sivilingeniørutdanningen STE6237 ELEMENTMETODER. Oppgaver

Høgskolen i Narvik Sivilingeniørutdanningen STE6237 ELEMENTMETODER. Oppgaver Høgskolen i Narvik Sivilingeniørutdanningen STE637 ELEMENTMETODER Oppgaver Klasse: 4.ID, 4.IT Ekstern Professor: Gregory A. Chechkin e-mail: chechkin@mech.math.msu.su Narvik 6 PART I Task. Consider two-point

More information

Høgskolen i Narvik Sivilingeniørutdanningen

Høgskolen i Narvik Sivilingeniørutdanningen Høgskolen i Narvik Sivilingeniørutdanningen Eksamen i Faget STE6237 ELEMENTMETODEN Klassen: 4.ID 4.IT Dato: 8.8.25 Tid: Kl. 9. 2. Tillatte hjelpemidler under eksamen: Kalkulator. Bok Numerical solution

More information

Scientic Computing 2013 Computer Classes: Worksheet 11: 1D FEM and boundary conditions

Scientic Computing 2013 Computer Classes: Worksheet 11: 1D FEM and boundary conditions Scientic Computing 213 Computer Classes: Worksheet 11: 1D FEM and boundary conditions Oleg Batrashev November 14, 213 This material partially reiterates the material given on the lecture (see the slides)

More information

Class Meeting # 1: Introduction to PDEs

Class Meeting # 1: Introduction to PDEs MATH 18.152 COURSE NOTES - CLASS MEETING # 1 18.152 Introduction to PDEs, Fall 2011 Professor: Jared Speck Class Meeting # 1: Introduction to PDEs 1. What is a PDE? We will be studying functions u = u(x

More information

Elasticity Theory Basics

Elasticity Theory Basics G22.3033-002: Topics in Computer Graphics: Lecture #7 Geometric Modeling New York University Elasticity Theory Basics Lecture #7: 20 October 2003 Lecturer: Denis Zorin Scribe: Adrian Secord, Yotam Gingold

More information

1 Completeness of a Set of Eigenfunctions. Lecturer: Naoki Saito Scribe: Alexander Sheynis/Allen Xue. May 3, 2007. 1.1 The Neumann Boundary Condition

1 Completeness of a Set of Eigenfunctions. Lecturer: Naoki Saito Scribe: Alexander Sheynis/Allen Xue. May 3, 2007. 1.1 The Neumann Boundary Condition MAT 280: Laplacian Eigenfunctions: Theory, Applications, and Computations Lecture 11: Laplacian Eigenvalue Problems for General Domains III. Completeness of a Set of Eigenfunctions and the Justification

More information

Numerical Analysis Lecture Notes

Numerical Analysis Lecture Notes Numerical Analysis Lecture Notes Peter J. Olver 5. Inner Products and Norms The norm of a vector is a measure of its size. Besides the familiar Euclidean norm based on the dot product, there are a number

More information

Inner Product Spaces

Inner Product Spaces Math 571 Inner Product Spaces 1. Preliminaries An inner product space is a vector space V along with a function, called an inner product which associates each pair of vectors u, v with a scalar u, v, and

More information

UNIVERSITETET I OSLO

UNIVERSITETET I OSLO NIVERSITETET I OSLO Det matematisk-naturvitenskapelige fakultet Examination in: Trial exam Partial differential equations and Sobolev spaces I. Day of examination: November 18. 2009. Examination hours:

More information

Inner product. Definition of inner product

Inner product. Definition of inner product Math 20F Linear Algebra Lecture 25 1 Inner product Review: Definition of inner product. Slide 1 Norm and distance. Orthogonal vectors. Orthogonal complement. Orthogonal basis. Definition of inner product

More information

Lecture Notes to Accompany. Scientific Computing An Introductory Survey. by Michael T. Heath. Chapter 10

Lecture Notes to Accompany. Scientific Computing An Introductory Survey. by Michael T. Heath. Chapter 10 Lecture Notes to Accompany Scientific Computing An Introductory Survey Second Edition by Michael T. Heath Chapter 10 Boundary Value Problems for Ordinary Differential Equations Copyright c 2001. Reproduction

More information

MATH 425, PRACTICE FINAL EXAM SOLUTIONS.

MATH 425, PRACTICE FINAL EXAM SOLUTIONS. MATH 45, PRACTICE FINAL EXAM SOLUTIONS. Exercise. a Is the operator L defined on smooth functions of x, y by L u := u xx + cosu linear? b Does the answer change if we replace the operator L by the operator

More information

Linear Algebra Notes for Marsden and Tromba Vector Calculus

Linear Algebra Notes for Marsden and Tromba Vector Calculus Linear Algebra Notes for Marsden and Tromba Vector Calculus n-dimensional Euclidean Space and Matrices Definition of n space As was learned in Math b, a point in Euclidean three space can be thought of

More information

AN INTRODUCTION TO NUMERICAL METHODS AND ANALYSIS

AN INTRODUCTION TO NUMERICAL METHODS AND ANALYSIS AN INTRODUCTION TO NUMERICAL METHODS AND ANALYSIS Revised Edition James Epperson Mathematical Reviews BICENTENNIAL 0, 1 8 0 7 z ewiley wu 2007 r71 BICENTENNIAL WILEY-INTERSCIENCE A John Wiley & Sons, Inc.,

More information

SIXTY STUDY QUESTIONS TO THE COURSE NUMERISK BEHANDLING AV DIFFERENTIALEKVATIONER I

SIXTY STUDY QUESTIONS TO THE COURSE NUMERISK BEHANDLING AV DIFFERENTIALEKVATIONER I Lennart Edsberg, Nada, KTH Autumn 2008 SIXTY STUDY QUESTIONS TO THE COURSE NUMERISK BEHANDLING AV DIFFERENTIALEKVATIONER I Parameter values and functions occurring in the questions belowwill be exchanged

More information

Inner Product Spaces and Orthogonality

Inner Product Spaces and Orthogonality Inner Product Spaces and Orthogonality week 3-4 Fall 2006 Dot product of R n The inner product or dot product of R n is a function, defined by u, v a b + a 2 b 2 + + a n b n for u a, a 2,, a n T, v b,

More information

Tensor product of vector spaces

Tensor product of vector spaces Tensor product of vector spaces Construction Let V,W be vector spaces over K = R or C. Let F denote the vector space freely generated by the set V W and let N F denote the subspace spanned by the elements

More information

The Heat Equation. Lectures INF2320 p. 1/88

The Heat Equation. Lectures INF2320 p. 1/88 The Heat Equation Lectures INF232 p. 1/88 Lectures INF232 p. 2/88 The Heat Equation We study the heat equation: u t = u xx for x (,1), t >, (1) u(,t) = u(1,t) = for t >, (2) u(x,) = f(x) for x (,1), (3)

More information

Mean value theorem, Taylors Theorem, Maxima and Minima.

Mean value theorem, Taylors Theorem, Maxima and Minima. MA 001 Preparatory Mathematics I. Complex numbers as ordered pairs. Argand s diagram. Triangle inequality. De Moivre s Theorem. Algebra: Quadratic equations and express-ions. Permutations and Combinations.

More information

BANACH AND HILBERT SPACE REVIEW

BANACH AND HILBERT SPACE REVIEW BANACH AND HILBET SPACE EVIEW CHISTOPHE HEIL These notes will briefly review some basic concepts related to the theory of Banach and Hilbert spaces. We are not trying to give a complete development, but

More information

MATH 304 Linear Algebra Lecture 20: Inner product spaces. Orthogonal sets.

MATH 304 Linear Algebra Lecture 20: Inner product spaces. Orthogonal sets. MATH 304 Linear Algebra Lecture 20: Inner product spaces. Orthogonal sets. Norm The notion of norm generalizes the notion of length of a vector in R n. Definition. Let V be a vector space. A function α

More information

Section 6.1 - Inner Products and Norms

Section 6.1 - Inner Products and Norms Section 6.1 - Inner Products and Norms Definition. Let V be a vector space over F {R, C}. An inner product on V is a function that assigns, to every ordered pair of vectors x and y in V, a scalar in F,

More information

MATRIX ALGEBRA AND SYSTEMS OF EQUATIONS. + + x 2. x n. a 11 a 12 a 1n b 1 a 21 a 22 a 2n b 2 a 31 a 32 a 3n b 3. a m1 a m2 a mn b m

MATRIX ALGEBRA AND SYSTEMS OF EQUATIONS. + + x 2. x n. a 11 a 12 a 1n b 1 a 21 a 22 a 2n b 2 a 31 a 32 a 3n b 3. a m1 a m2 a mn b m MATRIX ALGEBRA AND SYSTEMS OF EQUATIONS 1. SYSTEMS OF EQUATIONS AND MATRICES 1.1. Representation of a linear system. The general system of m equations in n unknowns can be written a 11 x 1 + a 12 x 2 +

More information

An Introduction to Partial Differential Equations

An Introduction to Partial Differential Equations An Introduction to Partial Differential Equations Andrew J. Bernoff LECTURE 2 Cooling of a Hot Bar: The Diffusion Equation 2.1. Outline of Lecture An Introduction to Heat Flow Derivation of the Diffusion

More information

Numerical Methods for Differential Equations

Numerical Methods for Differential Equations Numerical Methods for Differential Equations Course objectives and preliminaries Gustaf Söderlind and Carmen Arévalo Numerical Analysis, Lund University Textbooks: A First Course in the Numerical Analysis

More information

Similarity and Diagonalization. Similar Matrices

Similarity and Diagonalization. Similar Matrices MATH022 Linear Algebra Brief lecture notes 48 Similarity and Diagonalization Similar Matrices Let A and B be n n matrices. We say that A is similar to B if there is an invertible n n matrix P such that

More information

Vector and Matrix Norms

Vector and Matrix Norms Chapter 1 Vector and Matrix Norms 11 Vector Spaces Let F be a field (such as the real numbers, R, or complex numbers, C) with elements called scalars A Vector Space, V, over the field F is a non-empty

More information

Nonlinear Algebraic Equations. Lectures INF2320 p. 1/88

Nonlinear Algebraic Equations. Lectures INF2320 p. 1/88 Nonlinear Algebraic Equations Lectures INF2320 p. 1/88 Lectures INF2320 p. 2/88 Nonlinear algebraic equations When solving the system u (t) = g(u), u(0) = u 0, (1) with an implicit Euler scheme we have

More information

Recall that two vectors in are perpendicular or orthogonal provided that their dot

Recall that two vectors in are perpendicular or orthogonal provided that their dot Orthogonal Complements and Projections Recall that two vectors in are perpendicular or orthogonal provided that their dot product vanishes That is, if and only if Example 1 The vectors in are orthogonal

More information

A QUICK GUIDE TO THE FORMULAS OF MULTIVARIABLE CALCULUS

A QUICK GUIDE TO THE FORMULAS OF MULTIVARIABLE CALCULUS A QUIK GUIDE TO THE FOMULAS OF MULTIVAIABLE ALULUS ontents 1. Analytic Geometry 2 1.1. Definition of a Vector 2 1.2. Scalar Product 2 1.3. Properties of the Scalar Product 2 1.4. Length and Unit Vectors

More information

3. INNER PRODUCT SPACES

3. INNER PRODUCT SPACES . INNER PRODUCT SPACES.. Definition So far we have studied abstract vector spaces. These are a generalisation of the geometric spaces R and R. But these have more structure than just that of a vector space.

More information

Notes on Symmetric Matrices

Notes on Symmetric Matrices CPSC 536N: Randomized Algorithms 2011-12 Term 2 Notes on Symmetric Matrices Prof. Nick Harvey University of British Columbia 1 Symmetric Matrices We review some basic results concerning symmetric matrices.

More information

EXISTENCE AND NON-EXISTENCE RESULTS FOR A NONLINEAR HEAT EQUATION

EXISTENCE AND NON-EXISTENCE RESULTS FOR A NONLINEAR HEAT EQUATION Sixth Mississippi State Conference on Differential Equations and Computational Simulations, Electronic Journal of Differential Equations, Conference 5 (7), pp. 5 65. ISSN: 7-669. UL: http://ejde.math.txstate.edu

More information

0 <β 1 let u(x) u(y) kuk u := sup u(x) and [u] β := sup

0 <β 1 let u(x) u(y) kuk u := sup u(x) and [u] β := sup 456 BRUCE K. DRIVER 24. Hölder Spaces Notation 24.1. Let Ω be an open subset of R d,bc(ω) and BC( Ω) be the bounded continuous functions on Ω and Ω respectively. By identifying f BC( Ω) with f Ω BC(Ω),

More information

OPTIMAL CONTROL OF A COMMERCIAL LOAN REPAYMENT PLAN. E.V. Grigorieva. E.N. Khailov

OPTIMAL CONTROL OF A COMMERCIAL LOAN REPAYMENT PLAN. E.V. Grigorieva. E.N. Khailov DISCRETE AND CONTINUOUS Website: http://aimsciences.org DYNAMICAL SYSTEMS Supplement Volume 2005 pp. 345 354 OPTIMAL CONTROL OF A COMMERCIAL LOAN REPAYMENT PLAN E.V. Grigorieva Department of Mathematics

More information

The Method of Least Squares

The Method of Least Squares The Method of Least Squares Steven J. Miller Mathematics Department Brown University Providence, RI 0292 Abstract The Method of Least Squares is a procedure to determine the best fit line to data; the

More information

Multigrid preconditioning for nonlinear (degenerate) parabolic equations with application to monument degradation

Multigrid preconditioning for nonlinear (degenerate) parabolic equations with application to monument degradation Multigrid preconditioning for nonlinear (degenerate) parabolic equations with application to monument degradation M. Donatelli 1 M. Semplice S. Serra-Capizzano 1 1 Department of Science and High Technology

More information

NUMERICAL METHODS TOPICS FOR RESEARCH PAPERS

NUMERICAL METHODS TOPICS FOR RESEARCH PAPERS Faculty of Civil Engineering Belgrade Master Study COMPUTATIONAL ENGINEERING Fall semester 2004/2005 NUMERICAL METHODS TOPICS FOR RESEARCH PAPERS 1. NUMERICAL METHODS IN FINITE ELEMENT ANALYSIS - Matrices

More information

NOV - 30211/II. 1. Let f(z) = sin z, z C. Then f(z) : 3. Let the sequence {a n } be given. (A) is bounded in the complex plane

NOV - 30211/II. 1. Let f(z) = sin z, z C. Then f(z) : 3. Let the sequence {a n } be given. (A) is bounded in the complex plane Mathematical Sciences Paper II Time Allowed : 75 Minutes] [Maximum Marks : 100 Note : This Paper contains Fifty (50) multiple choice questions. Each question carries Two () marks. Attempt All questions.

More information

Module 1 : Conduction. Lecture 5 : 1D conduction example problems. 2D conduction

Module 1 : Conduction. Lecture 5 : 1D conduction example problems. 2D conduction Module 1 : Conduction Lecture 5 : 1D conduction example problems. 2D conduction Objectives In this class: An example of optimization for insulation thickness is solved. The 1D conduction is considered

More information

CONTROLLABILITY. Chapter 2. 2.1 Reachable Set and Controllability. Suppose we have a linear system described by the state equation

CONTROLLABILITY. Chapter 2. 2.1 Reachable Set and Controllability. Suppose we have a linear system described by the state equation Chapter 2 CONTROLLABILITY 2 Reachable Set and Controllability Suppose we have a linear system described by the state equation ẋ Ax + Bu (2) x() x Consider the following problem For a given vector x in

More information

Plates and Shells: Theory and Computation - 4D9 - Dr Fehmi Cirak (fc286@) Office: Inglis building mezzanine level (INO 31)

Plates and Shells: Theory and Computation - 4D9 - Dr Fehmi Cirak (fc286@) Office: Inglis building mezzanine level (INO 31) Plates and Shells: Theory and Computation - 4D9 - Dr Fehmi Cirak (fc286@) Office: Inglis building mezzanine level (INO 31) Outline -1-! This part of the module consists of seven lectures and will focus

More information

4. Complex integration: Cauchy integral theorem and Cauchy integral formulas. Definite integral of a complex-valued function of a real variable

4. Complex integration: Cauchy integral theorem and Cauchy integral formulas. Definite integral of a complex-valued function of a real variable 4. Complex integration: Cauchy integral theorem and Cauchy integral formulas Definite integral of a complex-valued function of a real variable Consider a complex valued function f(t) of a real variable

More information

DOKUZ EYLUL UNIVERSITY GRADUATE SCHOOL OF NATURAL AND APPLIED SCIENCES DIRECTORATE COURSE / MODULE / BLOCK DETAILS ACADEMIC YEAR / SEMESTER

DOKUZ EYLUL UNIVERSITY GRADUATE SCHOOL OF NATURAL AND APPLIED SCIENCES DIRECTORATE COURSE / MODULE / BLOCK DETAILS ACADEMIC YEAR / SEMESTER Offered by: Fen Bilimleri Enstitüsü Course Title: Applied Mathematics Course Org. Title: Applied Mathematics Course Level: Lisansüstü Course Code: MAT 5001 Language of Instruction: İngilizce Form Submitting/Renewal

More information

Section 4.4 Inner Product Spaces

Section 4.4 Inner Product Spaces Section 4.4 Inner Product Spaces In our discussion of vector spaces the specific nature of F as a field, other than the fact that it is a field, has played virtually no role. In this section we no longer

More information

We shall turn our attention to solving linear systems of equations. Ax = b

We shall turn our attention to solving linear systems of equations. Ax = b 59 Linear Algebra We shall turn our attention to solving linear systems of equations Ax = b where A R m n, x R n, and b R m. We already saw examples of methods that required the solution of a linear system

More information

Problem Set 5 Due: In class Thursday, Oct. 18 Late papers will be accepted until 1:00 PM Friday.

Problem Set 5 Due: In class Thursday, Oct. 18 Late papers will be accepted until 1:00 PM Friday. Math 312, Fall 2012 Jerry L. Kazdan Problem Set 5 Due: In class Thursday, Oct. 18 Late papers will be accepted until 1:00 PM Friday. In addition to the problems below, you should also know how to solve

More information

10. Proximal point method

10. Proximal point method L. Vandenberghe EE236C Spring 2013-14) 10. Proximal point method proximal point method augmented Lagrangian method Moreau-Yosida smoothing 10-1 Proximal point method a conceptual algorithm for minimizing

More information

MATRIX ALGEBRA AND SYSTEMS OF EQUATIONS

MATRIX ALGEBRA AND SYSTEMS OF EQUATIONS MATRIX ALGEBRA AND SYSTEMS OF EQUATIONS Systems of Equations and Matrices Representation of a linear system The general system of m equations in n unknowns can be written a x + a 2 x 2 + + a n x n b a

More information

An Additive Neumann-Neumann Method for Mortar Finite Element for 4th Order Problems

An Additive Neumann-Neumann Method for Mortar Finite Element for 4th Order Problems An Additive eumann-eumann Method for Mortar Finite Element for 4th Order Problems Leszek Marcinkowski Department of Mathematics, University of Warsaw, Banacha 2, 02-097 Warszawa, Poland, Leszek.Marcinkowski@mimuw.edu.pl

More information

FINITE DIFFERENCE METHODS

FINITE DIFFERENCE METHODS FINITE DIFFERENCE METHODS LONG CHEN Te best known metods, finite difference, consists of replacing eac derivative by a difference quotient in te classic formulation. It is simple to code and economic to

More information

Lecture 1: Schur s Unitary Triangularization Theorem

Lecture 1: Schur s Unitary Triangularization Theorem Lecture 1: Schur s Unitary Triangularization Theorem This lecture introduces the notion of unitary equivalence and presents Schur s theorem and some of its consequences It roughly corresponds to Sections

More information

Chapter 6. Orthogonality

Chapter 6. Orthogonality 6.3 Orthogonal Matrices 1 Chapter 6. Orthogonality 6.3 Orthogonal Matrices Definition 6.4. An n n matrix A is orthogonal if A T A = I. Note. We will see that the columns of an orthogonal matrix must be

More information

A new Feynman-Kac-formula for option pricing in Lévy models

A new Feynman-Kac-formula for option pricing in Lévy models A new Feynman-Kac-formula for option pricing in Lévy models Kathrin Glau Department of Mathematical Stochastics, Universtity of Freiburg (Joint work with E. Eberlein) 6th World Congress of the Bachelier

More information

Exact shape-reconstruction by one-step linearization in electrical impedance tomography

Exact shape-reconstruction by one-step linearization in electrical impedance tomography Exact shape-reconstruction by one-step linearization in electrical impedance tomography Bastian von Harrach harrach@math.uni-mainz.de Institut für Mathematik, Joh. Gutenberg-Universität Mainz, Germany

More information

Inner products on R n, and more

Inner products on R n, and more Inner products on R n, and more Peyam Ryan Tabrizian Friday, April 12th, 2013 1 Introduction You might be wondering: Are there inner products on R n that are not the usual dot product x y = x 1 y 1 + +

More information

1 Introduction to Matrices

1 Introduction to Matrices 1 Introduction to Matrices In this section, important definitions and results from matrix algebra that are useful in regression analysis are introduced. While all statements below regarding the columns

More information

8 Hyperbolic Systems of First-Order Equations

8 Hyperbolic Systems of First-Order Equations 8 Hyperbolic Systems of First-Order Equations Ref: Evans, Sec 73 8 Definitions and Examples Let U : R n (, ) R m Let A i (x, t) beanm m matrix for i,,n Let F : R n (, ) R m Consider the system U t + A

More information

Bindel, Spring 2012 Intro to Scientific Computing (CS 3220) Week 3: Wednesday, Feb 8

Bindel, Spring 2012 Intro to Scientific Computing (CS 3220) Week 3: Wednesday, Feb 8 Spaces and bases Week 3: Wednesday, Feb 8 I have two favorite vector spaces 1 : R n and the space P d of polynomials of degree at most d. For R n, we have a canonical basis: R n = span{e 1, e 2,..., e

More information

3. Reaction Diffusion Equations Consider the following ODE model for population growth

3. Reaction Diffusion Equations Consider the following ODE model for population growth 3. Reaction Diffusion Equations Consider the following ODE model for population growth u t a u t u t, u 0 u 0 where u t denotes the population size at time t, and a u plays the role of the population dependent

More information

No: 10 04. Bilkent University. Monotonic Extension. Farhad Husseinov. Discussion Papers. Department of Economics

No: 10 04. Bilkent University. Monotonic Extension. Farhad Husseinov. Discussion Papers. Department of Economics No: 10 04 Bilkent University Monotonic Extension Farhad Husseinov Discussion Papers Department of Economics The Discussion Papers of the Department of Economics are intended to make the initial results

More information

1 if 1 x 0 1 if 0 x 1

1 if 1 x 0 1 if 0 x 1 Chapter 3 Continuity In this chapter we begin by defining the fundamental notion of continuity for real valued functions of a single real variable. When trying to decide whether a given function is or

More information

THE FUNDAMENTAL THEOREM OF ALGEBRA VIA PROPER MAPS

THE FUNDAMENTAL THEOREM OF ALGEBRA VIA PROPER MAPS THE FUNDAMENTAL THEOREM OF ALGEBRA VIA PROPER MAPS KEITH CONRAD 1. Introduction The Fundamental Theorem of Algebra says every nonconstant polynomial with complex coefficients can be factored into linear

More information

Fixed Point Theorems

Fixed Point Theorems Fixed Point Theorems Definition: Let X be a set and let T : X X be a function that maps X into itself. (Such a function is often called an operator, a transformation, or a transform on X, and the notation

More information

7 Gaussian Elimination and LU Factorization

7 Gaussian Elimination and LU Factorization 7 Gaussian Elimination and LU Factorization In this final section on matrix factorization methods for solving Ax = b we want to take a closer look at Gaussian elimination (probably the best known method

More information

Adaptive Online Gradient Descent

Adaptive Online Gradient Descent Adaptive Online Gradient Descent Peter L Bartlett Division of Computer Science Department of Statistics UC Berkeley Berkeley, CA 94709 bartlett@csberkeleyedu Elad Hazan IBM Almaden Research Center 650

More information

Linear-Quadratic Optimal Controller 10.3 Optimal Linear Control Systems

Linear-Quadratic Optimal Controller 10.3 Optimal Linear Control Systems Linear-Quadratic Optimal Controller 10.3 Optimal Linear Control Systems In Chapters 8 and 9 of this book we have designed dynamic controllers such that the closed-loop systems display the desired transient

More information

(67902) Topics in Theory and Complexity Nov 2, 2006. Lecture 7

(67902) Topics in Theory and Complexity Nov 2, 2006. Lecture 7 (67902) Topics in Theory and Complexity Nov 2, 2006 Lecturer: Irit Dinur Lecture 7 Scribe: Rani Lekach 1 Lecture overview This Lecture consists of two parts In the first part we will refresh the definition

More information

Continuity of the Perron Root

Continuity of the Perron Root Linear and Multilinear Algebra http://dx.doi.org/10.1080/03081087.2014.934233 ArXiv: 1407.7564 (http://arxiv.org/abs/1407.7564) Continuity of the Perron Root Carl D. Meyer Department of Mathematics, North

More information

Feature Commercial codes In-house codes

Feature Commercial codes In-house codes A simple finite element solver for thermo-mechanical problems Keywords: Scilab, Open source software, thermo-elasticity Introduction In this paper we would like to show how it is possible to develop a

More information

Metric Spaces. Chapter 7. 7.1. Metrics

Metric Spaces. Chapter 7. 7.1. Metrics Chapter 7 Metric Spaces A metric space is a set X that has a notion of the distance d(x, y) between every pair of points x, y X. The purpose of this chapter is to introduce metric spaces and give some

More information

A gentle introduction to the Finite Element Method. Francisco Javier Sayas

A gentle introduction to the Finite Element Method. Francisco Javier Sayas A gentle introduction to the Finite Element Method Francisco Javier Sayas 2008 An introduction If you haven t been hiding under a stone during your studies of engineering, mathematics or physics, it is

More information

SOLUTIONS TO EXERCISES FOR. MATHEMATICS 205A Part 3. Spaces with special properties

SOLUTIONS TO EXERCISES FOR. MATHEMATICS 205A Part 3. Spaces with special properties SOLUTIONS TO EXERCISES FOR MATHEMATICS 205A Part 3 Fall 2008 III. Spaces with special properties III.1 : Compact spaces I Problems from Munkres, 26, pp. 170 172 3. Show that a finite union of compact subspaces

More information

Factoring Cubic Polynomials

Factoring Cubic Polynomials Factoring Cubic Polynomials Robert G. Underwood 1. Introduction There are at least two ways in which using the famous Cardano formulas (1545) to factor cubic polynomials present more difficulties than

More information

MATH PROBLEMS, WITH SOLUTIONS

MATH PROBLEMS, WITH SOLUTIONS MATH PROBLEMS, WITH SOLUTIONS OVIDIU MUNTEANU These are free online notes that I wrote to assist students that wish to test their math skills with some problems that go beyond the usual curriculum. These

More information

MATHEMATICAL METHODS OF STATISTICS

MATHEMATICAL METHODS OF STATISTICS MATHEMATICAL METHODS OF STATISTICS By HARALD CRAMER TROFESSOK IN THE UNIVERSITY OF STOCKHOLM Princeton PRINCETON UNIVERSITY PRESS 1946 TABLE OF CONTENTS. First Part. MATHEMATICAL INTRODUCTION. CHAPTERS

More information

FEM Software Automation, with a case study on the Stokes Equations

FEM Software Automation, with a case study on the Stokes Equations FEM Automation, with a case study on the Stokes Equations FEM Andy R Terrel Advisors: L R Scott and R C Kirby Numerical from Department of Computer Science University of Chicago March 1, 2006 Masters Presentation

More information

State of Stress at Point

State of Stress at Point State of Stress at Point Einstein Notation The basic idea of Einstein notation is that a covector and a vector can form a scalar: This is typically written as an explicit sum: According to this convention,

More information

Chapter 20. Vector Spaces and Bases

Chapter 20. Vector Spaces and Bases Chapter 20. Vector Spaces and Bases In this course, we have proceeded step-by-step through low-dimensional Linear Algebra. We have looked at lines, planes, hyperplanes, and have seen that there is no limit

More information

Pacific Journal of Mathematics

Pacific Journal of Mathematics Pacific Journal of Mathematics GLOBAL EXISTENCE AND DECREASING PROPERTY OF BOUNDARY VALUES OF SOLUTIONS TO PARABOLIC EQUATIONS WITH NONLOCAL BOUNDARY CONDITIONS Sangwon Seo Volume 193 No. 1 March 2000

More information

Factorization Theorems

Factorization Theorems Chapter 7 Factorization Theorems This chapter highlights a few of the many factorization theorems for matrices While some factorization results are relatively direct, others are iterative While some factorization

More information

Notes V General Equilibrium: Positive Theory. 1 Walrasian Equilibrium and Excess Demand

Notes V General Equilibrium: Positive Theory. 1 Walrasian Equilibrium and Excess Demand Notes V General Equilibrium: Positive Theory In this lecture we go on considering a general equilibrium model of a private ownership economy. In contrast to the Notes IV, we focus on positive issues such

More information

Direct Methods for Solving Linear Systems. Matrix Factorization

Direct Methods for Solving Linear Systems. Matrix Factorization Direct Methods for Solving Linear Systems Matrix Factorization Numerical Analysis (9th Edition) R L Burden & J D Faires Beamer Presentation Slides prepared by John Carroll Dublin City University c 2011

More information

3 Orthogonal Vectors and Matrices

3 Orthogonal Vectors and Matrices 3 Orthogonal Vectors and Matrices The linear algebra portion of this course focuses on three matrix factorizations: QR factorization, singular valued decomposition (SVD), and LU factorization The first

More information

Advanced Computational Fluid Dynamics AA215A Lecture 5

Advanced Computational Fluid Dynamics AA215A Lecture 5 Advanced Computational Fluid Dynamics AA5A Lecture 5 Antony Jameson Winter Quarter, 0, Stanford, CA Abstract Lecture 5 shock capturing schemes for scalar conservation laws Contents Shock Capturing Schemes

More information

2.3 Convex Constrained Optimization Problems

2.3 Convex Constrained Optimization Problems 42 CHAPTER 2. FUNDAMENTAL CONCEPTS IN CONVEX OPTIMIZATION Theorem 15 Let f : R n R and h : R R. Consider g(x) = h(f(x)) for all x R n. The function g is convex if either of the following two conditions

More information

1 Inner Products and Norms on Real Vector Spaces

1 Inner Products and Norms on Real Vector Spaces Math 373: Principles Techniques of Applied Mathematics Spring 29 The 2 Inner Product 1 Inner Products Norms on Real Vector Spaces Recall that an inner product on a real vector space V is a function from

More information

SOLVING LINEAR SYSTEMS

SOLVING LINEAR SYSTEMS SOLVING LINEAR SYSTEMS Linear systems Ax = b occur widely in applied mathematics They occur as direct formulations of real world problems; but more often, they occur as a part of the numerical analysis

More information

NOTES ON LINEAR TRANSFORMATIONS

NOTES ON LINEAR TRANSFORMATIONS NOTES ON LINEAR TRANSFORMATIONS Definition 1. Let V and W be vector spaces. A function T : V W is a linear transformation from V to W if the following two properties hold. i T v + v = T v + T v for all

More information

Lecture 13 Linear quadratic Lyapunov theory

Lecture 13 Linear quadratic Lyapunov theory EE363 Winter 28-9 Lecture 13 Linear quadratic Lyapunov theory the Lyapunov equation Lyapunov stability conditions the Lyapunov operator and integral evaluating quadratic integrals analysis of ARE discrete-time

More information

Linköping University Electronic Press

Linköping University Electronic Press Linköping University Electronic Press Report Well-posed boundary conditions for the shallow water equations Sarmad Ghader and Jan Nordström Series: LiTH-MAT-R, 0348-960, No. 4 Available at: Linköping University

More information

1 VECTOR SPACES AND SUBSPACES

1 VECTOR SPACES AND SUBSPACES 1 VECTOR SPACES AND SUBSPACES What is a vector? Many are familiar with the concept of a vector as: Something which has magnitude and direction. an ordered pair or triple. a description for quantities such

More information

A PRIORI ESTIMATES FOR SEMISTABLE SOLUTIONS OF SEMILINEAR ELLIPTIC EQUATIONS. In memory of Rou-Huai Wang

A PRIORI ESTIMATES FOR SEMISTABLE SOLUTIONS OF SEMILINEAR ELLIPTIC EQUATIONS. In memory of Rou-Huai Wang A PRIORI ESTIMATES FOR SEMISTABLE SOLUTIONS OF SEMILINEAR ELLIPTIC EQUATIONS XAVIER CABRÉ, MANEL SANCHÓN, AND JOEL SPRUCK In memory of Rou-Huai Wang 1. Introduction In this note we consider semistable

More information

Linear Programming Notes V Problem Transformations

Linear Programming Notes V Problem Transformations Linear Programming Notes V Problem Transformations 1 Introduction Any linear programming problem can be rewritten in either of two standard forms. In the first form, the objective is to maximize, the material

More information

3. Let A and B be two n n orthogonal matrices. Then prove that AB and BA are both orthogonal matrices. Prove a similar result for unitary matrices.

3. Let A and B be two n n orthogonal matrices. Then prove that AB and BA are both orthogonal matrices. Prove a similar result for unitary matrices. Exercise 1 1. Let A be an n n orthogonal matrix. Then prove that (a) the rows of A form an orthonormal basis of R n. (b) the columns of A form an orthonormal basis of R n. (c) for any two vectors x,y R

More information

Example 4.1 (nonlinear pendulum dynamics with friction) Figure 4.1: Pendulum. asin. k, a, and b. We study stability of the origin x

Example 4.1 (nonlinear pendulum dynamics with friction) Figure 4.1: Pendulum. asin. k, a, and b. We study stability of the origin x Lecture 4. LaSalle s Invariance Principle We begin with a motivating eample. Eample 4.1 (nonlinear pendulum dynamics with friction) Figure 4.1: Pendulum Dynamics of a pendulum with friction can be written

More information

Linear Algebra Methods for Data Mining

Linear Algebra Methods for Data Mining Linear Algebra Methods for Data Mining Saara Hyvönen, Saara.Hyvonen@cs.helsinki.fi Spring 2007 Lecture 3: QR, least squares, linear regression Linear Algebra Methods for Data Mining, Spring 2007, University

More information

LINEAR ALGEBRA W W L CHEN

LINEAR ALGEBRA W W L CHEN LINEAR ALGEBRA W W L CHEN c W W L Chen, 1997, 2008 This chapter is available free to all individuals, on understanding that it is not to be used for financial gain, and may be downloaded and/or photocopied,

More information