Numerical Methods for Partial Differential Equations

Size: px
Start display at page:

Download "Numerical Methods for Partial Differential Equations"

Transcription

1 Numerical Methods for Partial Differential Equations CAAM 45 Spring 005 Lecture 15 Instructor: Tim Warburton

2

3 Two-Dimensional Advection Recall in one-dimensions we chose an arbitrary section of a pipe. We monitored the flux of fluid into and out of the ends of the pipe. The conservation equation in 1D we derived was: b d C = u b t C b t + u a t C a t dt a (, ) (, ) (, ) (, ) Now we start with a D domain and consider any simply connected sub-region:

4 Our D Domain Ω Ω

5 Our Sub-region ω Ω ω

6 Outward Normal n Ω n ω

7 Conservation Suppose the fluid has a mean velocity everywhere. u This time is a two-vector. n=outward pointing normal u ω u The flux of fluid through the boundary is the integral of the concentration C being advected normal to the surface of w: flux = ( u n) CdS ω

8 Conservation Law Now we know how much of the concentrate is being advected through the boundary of our subregion. d CdV = ( u n) CdS dt ω ω The conservation law is now: We apply the divergence theorem (beware this relies on smoothness arguments): d CdV = ( u n) CdS dt ω ω = ω uc dv ( )

9 In Component Form Assuming ubar is constant this becomes: u u = v x = x d CdV = ( u ) CdV dt ω ω = u + v CdV x y ω

10 For all sub-regions: Finalize d CdV + u + v CdV dt x y ω C C C = + u + v dv = t x y ω Assuming enough continuity we obtain: ω C C C + u + v = 0 t x y 0

11 Basic Technology For Meshes in D Our target is to be able to use triangulations of a domain in D. For example here we have a 5 triangle mesh of an L-shape domain:

12 Global Vertex Numbering In order to represent the topology of the triangles we create a global numbering of the unique vertices in the mesh: Notice the allocation of number to vertex is arbitrary.

13 Triangle as Ordered Triplet We next label each triangle in the mesh (numbers in triangles): Again the labeling of the triangles is in an arbitrary order.

14 Triangle as Ordered Triplet cont We can represent each triangle as a triplet of integers which are the global vertex numbers of the triangle in a counter-clockwise ordering: Triangle 1: 7,5,3 Triangle :,5,7 Triangle 3: 4,6,1 Triangle 4: 1,7,4 Triangle 5:,7,

15 Class Exercise Part 1 Given this element to vertex representation of the mesh, can you determine determine the topology of the triangle (i.e. what might the mesh look like)? Triangle 1:,3,6 Triangle : 5,3, Triangle 3: 6,3,1 Triangle 4:,6,4 What is the cost of your algorithm?

16 Class Exercise Part Given this element to vertex representation of the mesh, can you determine which triangles share an edge: Triangle 1: 1,,9 Triangle :,3,9 Triangle 3: 3,4,5 Triangle 4: 3,5,6 Triangle 5: 3,6,9 Triangle 6: 9,6,7 Triangle 7: 8,9,7 What is the cost of your algorithm?

17 Naïve Algorithm We could naively try a brute force search. Two triangles will share an edge if they both contain two vertices in common. a b So the obvious algorithm is:

18 Alogithm 1 Brute force test to see which out of all the edges connects to a given edge. Cost approx. 9*K^ We can trim the number of tests by ½ easily (loop elmt=elmt1+1:k and store result in (elmt1,edge1) and (elmt,edge). Very loopy so Matlab will be very slow.

19 Alogithm Set up the edge to node matrix using Matlab s sparse matrix facility. Thinking about the connectivity matrices as sparse matrices allows us to easily find other connectivities: NodeToEdge = transpose(edgetonode)

20 Topology Determined So with either approach we now know the topology of the triangles (i.e. which triangles share an edge). Consider the advection equation: q + c q = 0 t or it's conservation law version: We can use this as the foundation of an upwind finite volume solver: d dt T k qda 3 k, e e= k, e dq 1 c n c n k = k e dt T k e= 1 edge e where k = ElmtToElmt( k, e) e = c nqds T ( q q ) k k

21 Geometric Factors With T k being the k th triangle we need to be able to compute T k and the outward facing unit normals on,,, each edge e= 3 k e k e n k e n k, n k,3 k,1 v n, k,1 v k dq 1 c n c n k = e dt T k e= 1 edge e where k = ElmtToElmt( k, e) k,3 v y y k,1 k, k,1 L s ( vx vx ) e ( qk qk ) v v n L v v k, k,1 k,1 1 k,1 k, k,1 = where s = v v n k,3 k, L v v ( vx vx ) k,3 k, k, 1 y y k, k,3 k, = where k, s = L s v v n k,1 k, L v v ( vx vx ) k,1 k,3 k,3 1 y y k,3 k,1 k,3 = where k,3 s = L s

22 Computing the Area of a Triangle We can use a simple geometric argument to determine the area of a triangle: 1 k, k,1 k,3 k,1 Tk = ( v v ) ( v v ) 1 = k, k,1 k,3 k,1 k, k,1 k,3 k,1 ( vx vx )( vy vy ) ( vy vy )( vx vx )

23 cont We make some approximations: 1) that q is in fact constant over the element ) Euler-forward in time and we obtain: c n c n q q T q q e= 3 k, e k, e n+ 1 n dt n n k = k k, e k e k T k e= 1 k, e ( ) where T is the length of the e'th edge on triangle k

24 Notes on the Geometric Factors We use the formula: area of triangle = ½*(base*perpendicular height) k,1 h k, h k, L k,3 L k,1 L k,3 h L T k,1 k,1 k L = = 1 k,1 k,1 h L h k,1 L T k, k, k L = = 1 k, k, h L h k, L T k,3 k,3 k L = = 1 k,3 k,3 h L h k,3 The ratio of the edge length to triangle area gives divided by the perpendicular height from the edge to the vertex not on the edge.

25 cont Simplifying: c n c n q q dt q q e= 3 k, e k, e n+ 1 n n n k = k k, e k e k e= 1 h ( ) This looks very much like a one-dimensional scheme applied at each edge which it is. At each edge we use the component of the advection velocity in the direction of the outwards facing normal.

26 Project 1- Overview I grabbed a polygonal description of part of coast line of the UK and Eire: I then used the Triangle program by Shewchuk to generate a triangle mesh. Your task: solve the linearized Euler equations with a pressure pulse set off near the coast.

27 Project 1 - Equations The linearized Euler equations we will consider are: u p 0 v p = 0, BC: unx + vny = 0 t x y p u v where p is the pressure and u,v are the x and y components of the water velocity. The boundary condition states that at the boundary the velocity field is tangential to the boundary.

28 cont We write a first order finite-volume scheme for the linearized Euler equations using upwind fluxes for: u p 0 v p = 0, BC: unx + vny = 0 t x y p u v as (after board demo of characteristic treatment): u u n v v dt n n u u n v v p p p n+ 1 n k, e k k e= 3 x n+ 1 n 1 k, ek, e n n k, e n n n n k = k +, y x k k e e k + y k e k k e k n+ 1 n e= 1 h k p k 1 ( ( ) ( ) ( )) Boundary condition: n n n n n n u = u, v = v, p = p at the domain boundary k k k k k k e e e

29 Project Tasks Q1) Write code to read in the mesh from a.neu mesh file (more about that next time) Q) Write start up code to compute: The area of each triangle The length of each edge of each triangle The outwards facing unit normal at each edge of each triangle Q3) Implement the first order finite volume scheme for the linearized acoustics. Use a dt which obeys: ( k, e ) 1 0 dt C min h with safety factor C such that 0 C k, e

30 Project Tasks cont Q4) By generating a sequence of increasingly refined meshes for a square [-1,1]x[-1,1] find the solution order of accuracy of the scheme. A suitable initial condition is: (,,0) 0 (,,0) = 0 (,,0) cos( π ) cos( π ) u x y v x y p x y x y The solution for all time is: ( π x) ( π y) ( πt ) ( π ) ( π ) ( π ) ( π x) ( π y) ( πt ) sin cos sin / u( x, y, t) v( x, y, t ) cos x sin y sin t / = p( x, y, t) cos cos cos

31 Project Tasks cont Q5) Use the ocean mesh and model a pressure pulse (Gaussian profile) off the coast of England Repeat with 3 increasingly refined meshes to visually display and compare results. Plot snap shots at 4 time intervals showing the pulse spreading and interacting with the coast line. I will now demo how to build meshes with some in house software based on Shewchuk s triangle mesh generator.

32 Project Details You may work in groups of 1 or. No groups of 3 or more will be permitted. The project is due: 03/9/05 Be prepared to present your results (i.e. make a 5 minute PowerPoint presentation). Prepare a report and I strongly suggest using the Latex stylesheet available from the website.

33 More Advanced Than FV As you will find out the finite volume method is robust, but not very accurate. To increase the solution order of accuracy we are going to use the discontinuous Galerkin method (DGM or DG) The idea: on each triangle we create a p th order polynomial expansion local to the triangle. We then use a flux type formulation to exchange information between triangles.

34 Basics First we need to discuss how to create local polynomial approximations on each triangle. i.e. we need a robustly computable basis for i ( ) = x p j P T y T 0 i+j p In finite volume and finite element methods it is common to perform calculus type operations (integration, differentiation and interpolation) on a standard element and map the results to a physical element.

35 Reference Triangle The following will be our reference triangle: (-1,1) s r (-1,-1) (1,-1) The k th triangle is the image of this triangle under the map: k,1 k, k,3 x r + sv x 1+ rv x 1+ sv x k,1 k, k,3 y = + v + y v y vy

36 Reference Triangle Mapped To Physical Triangle A typical map will have the following action: (-1,1) s k,3 k,3 ( vx, vy ) (-1,-1) (1,-1) r k,1 k,1 ( vx, vy ) k, k, ( vx, vy ) k,1 k, k,3 x r + sv x 1+ rv x 1+ sv x k,1 k, k,3 y = + v + y v y v y

37 Orthonormal Basis for the Triangle Fortunately a well behaved, orthonormal basis for the triangle has been discovered (and rediscovered multiple times). First we need to know some details about the Jacobi polynomials. These polynomials are parameterized by two reals: α, β and their integer orders n,m such that they satisfy the orthogonality relationship (for integer alpha,beta): 1 α β ( n + ) ( n + ) n ( n ) 1 1 x 1+ x α, β α, β α! β! Pn ( x) Pm ( x) dx = δnm n + α + β + 1! + α + β! P α, β n ( 1) = ( n + α ) n! α! n β α ( ) = ( 1) ( ) P x P x α, β, n n!

38 Jacobi Polynomial Recurrence Relation We can generate the n th order Jacobi polynomials at a given x in [-1,1] through the following recurrence relationship: P α, β 0 ( x) = ( ) ( ) = ( α + ) + ( α + β + )( ) α, β P1 x x α, β ( n + )( n + α + β + )( n + α + β ) Pn + 1 ( x) = ( ) ( )( n + α + β +! ) α, β n + α + β + 1 α β + x Pn ( x) ( n + α + β 1 )! α, β ( n + α )( n + β )( n + α + β + ) P ( x) 1 1 See: n 1

39 Orthonormal Basis for the Triangle The following basis is due to Koornwinder (later revived by Proriol, Dubiner, Owens,.) φ 1 b 0,0 n+ 1,0 ( ) ( r, s, ) = P n m n ( a) Pm ( b) where: (1 + r) a = 1 (1 s) b = s It satisfies the following orthogonality condition: n 1 s 1 1 φ(, ) φ(, ) drds = δik δ i j k l jl i + 1 j + i +

40 cont Notice that the (n,m) basis member is an n+m th order polynomial. φ 1 b 0,0 n+ 1,0 ( ) ( r, s, ) = P n m n ( a) Pm ( b) where: (1 + r) a = 1 (1 s) b = s Moreover, the orthogonality property allows us to determine that the set of basis members with: n+m<=p supports all bivariate polynomials with maximum total degree p. n

41 Basis Ordering In order to simplify the notation we can order the polynomials with a single index (this is not a unique ordering): ψ1 = φ( 0,0) ψ p+ = φ( 0,1 ψ φ ) = ( 1,0 ) ψ p+ 3 = φ ψ φ ( 1,1 = ) ( ) ψ M = φ ψ p+ = φ ψ φ ( p 1,1 = ) p+ (,0) ( p) 3,0 0, 1 p where M=(p+1)(p+)/ and we have normalized each of the { ψ i }

42 cont Next class we will discuss how to use this basis to interpolate, differentiate and integrate data at points in the triangle. We continue here to discuss the question of which points to use on the triangle for polynomial interpolation.

43 Interpolation Using Generalized Vandermonde Matrix Given a set of nodes lying in the triangle we use V to construct an interpolating polynomial for a function who s values we know at the nodes: i= M The interpolation condition yields: i= M f r s r s fˆ (, ) = ψ (, ) j j i j j i i= 1 i= M f r, s ψ r, s fˆ ( ) ( ) i= 1 f r s = fˆ = r s (, ) V where V ψ (, ) j j ji i ji i j j i= 1 j= M fˆ =, ( 1 V ) f ( r s ) i ij j j j= 1 i i

44 Differentiation Suppose we wish to find the derivative of a p th order p j polynomial: f P T = x y ( ) i 0 i+j p First we note that the approximation becomes equality: And interpolation allows us to find the polynomial m= M coefficients: f r, s fˆ ( ) i= M f r, s ψ r, s fˆ = ( ) ( ) i= 1 n n nm m m= 1 So differentiation requires us to compute: T i = V i f r f s m= M m ( r, s) = (, ) m= 1 m= M m ( r, s) = (, ) m= 1 ψ r ψ s r s fˆ r s fˆ m m

45 Differentiation cont So we need to be able to compute: ψ and Recall the definition of the basis functions: φ r m ψ s ( ) ( ) 0,0 n+ r, s = P 1 1,0 nm n Pm ( s) m (1 + r) 1 s (1 s) n R-derivative: r 1 s dx (1 s) 0,0 n φ dp (1 + r) 1 s + m ( nm ) n n 1,0 ( r, s) = 1 P ( s)

46 Quick Jacobi Polynomial Identity We will make extensive use of the following: dp dx α, β n n + α + β = n 1 α 1, β 1 ( x) P ( x)

47 r-derivative Ok we need to calculate: 0,0 n φ dp (1 + r) 1 s + m r 1 s dx (1 s) ( nm ) n n 1,0 ( r, s) = 1 P ( s) n φ n + 1 (1 + r) 1 s + n 1 m ( nm ) 1,1 n 1,0 ( r, s) = P 1 P ( s) n 1 r 1 s (1 s) ( x) = = = α, β 0 when n 0 (since P0 1) We can compute these using the definition of the Jacobi polynomials. Watch out for s=1 (top vertex) the r-derivative of all the basis is functions is zero at r=1,s=-1

48 s-derivative We use the chain and product rule to obtain: ( r ) ( 1 s ) ( ) 0,0 n φ nm 1 + dpn (1 + r) 1 s n+ 1,0 ( r, s ) = 1 Pm s s dx (1 s) n 1 0,0 (1 + r) n 1 s n+ 1, 0 + Pn 1 Pm s (1 s) n 0, 0 (1 + r) 1 s + Pn 1 (1 s) dp dx n+ 1, 0 m ( s ) ( ) ( )

49 s-derivative From which: ( 1 ) ( 1 s ) ( ) n φ nm 1 1,1 (1 ) 1 s n 1,0 ( r, s + r n + + r ) Pn 1 1 m s (1 s) P + = s n 1 0,0 (1 + r) n 1 s n+ 1,0 + Pn 1 Pm s (1 s) n 0,0 (1 + r) 1 s + Pn 1 (1 s) m + n + ( ) P n+,1 m 1 ( s ) ( )

50 Special Cases φ ( 0m ) 1,0 ( r, s) = P ( s) s s { } m Don t worry about all those denominators having (1-s) since the functions are just polynomials and not singular functions

51 Recap n φ n + 1 (1 + r) 1 s + n 1 m ( nm ) 1,1 n 1,0 ( r, s) = P 1 P ( s) n 1 r 1 s (1 s) ( x) = = = α, β 0 when n 0 (since P0 1) ( ) n φ nm n + 1 1,1 (1 + r) 1 s n+ 1,0 ( r, s) = P n 1 1 Pm s s ( 1 s) (1 s) n 1 0,0 (1 + r) n1 s n+ 1,0 + Pn 1 Pm s (1 s) ( ) n 0,0 (1 + r) 1 s m + n + n+,1 n 1 Pm 1 + P (1 s) ( s) ( )

52 Derivative matrices Given data at M=(p+1)(p+)/ points we can directly r and s derivatives with: m= M fˆ =, ( 1 V ) f ( r s ) m mj j j m= 1 f r f s m= M ( ) ˆ r ˆ ˆ r m r, s = D f where D = ( r, s ) n n nm m nm n n m= 1 r m= M φ φ ( ) ˆ s ˆ ˆ s m r, s = D f where D = ( r, s ) n n nm m nm n n m= 1 s

53 One-Stage Differentiation Given a vector of values of f at a set of nodes we can obtain a vector of the r and s derivatives at the nodes by: f = r r where ˆ r D f D = D V r f = s s where = ˆ s D f D D V s 1 1

54 Inner Product Matrices We will we need to compute: f, g ( ) T = = T 1 s 1 1 fgdv f r, s g r, s ( ) ( ) x, y ( ) r, s ( ) drds It is not obvious how to do this given the value of f and g at a set of M points. Same old trick construct the polynomial coefficients with the Vandermonde matrix and use the orthogonality relationship..

55 Inner-Product ( f g ) 1 s ( x, y) f ( r s) g ( r s) drds ( r, s) s m= M n= M ( x, y) ˆ ( ) ˆ m m, n n ( ( r, s) φ φ 1 1 m= 1 n= 1, ) 1 s n= M m= M ( x, y) ˆ (, ) ˆ m m n n ( ( r, s) φ φ 1 1 n= 1 m= 1, ) n= M m= M 1 s ( x, y) ˆ m ˆ n φm (, ) φn ( ( r, s) n= 1 m= 1 1 1, ) n= M m= M ( x y) ˆ ˆ where C( ij) ( ) fmgnδ nmcn n= 1 m= 1 n= M ( x, y) fˆ ng ˆ ncn ( r, s) n= 1, =,, T = f r s g r s drds = f r s g r s drds = f g r s r s drds, = = r, s i + 1 i + j + = Since the r,s->x,y is linear

56 Summary So Far We are confident that given a set of (p+1)(p+)/ interpolation points we can use the orthogonal basis to perform differentiation, integration and interpolation. Now we should be concerned about how to choose the points. Recall in 1D interpolation it is tempting to use the equally spaced points on an interval but this can cause the Runge effect (wild oscillations in the interpolated function).

57 Accuracy of Polynomial Interpolation We introduce the operator supremum-norm and the L-infinity norm: p I f p I = sup where f = max f ( x, y) f 0 f ( x, y) T for the p th order interpolation operator: I p The interpolation error is bounded below by: * p (, ) (, ) (, ) (, ) f x y f x y f x y I f x y * where is the optimal polynomial approximation f in the. norm

58 cont This tells us that the interpolating polynomial which approximates a function can only be less or equal in accuracy to the best polynomial approximation. Finding the optimal polynomial which approximates a function is an unsolved problem. However, there is a theorem by Lebesgue which allows us to bound the interpolation error in terms of the error one would attain by choosing the best possible polynomial approximation.

59 Theorem (Lebesgue) ( ) Assume that f C T and we consider a set of M interpolation points then: p p * f I f 1+ Λ f f ( ) ( ) ( x, y) T i = 1 ( ) p p where Λ = I = max hi x, y is termed the Lebesgue constant and h x, y is the i'th Lagrange Cardinal function i i.e. the Lebesgue constant gives us an idea of the p optimality of the M points. The smaller Λ is the better. i= M

60 p * * p f I f f f + f I f ( ) * p ok since P T f Proof n= M * * f f f f ( xn yn ) hn ( x y) n= 1 + n= M n= M * * ( n, n ) n (, ) ( n, n ) n (, ) n= 1 n= 1 n= M * * triangle inequality,, definition of interpolant f f + f x y h x y f x y h x y { ( n, n ) ( n, n )} n (, ) f f + f x y f x y h x y n= 1 f f * n= M * f ( xn, yn ) f ( xn, yn ) hn ( x, y) n= 1 + n= M * * f f f f hn ( x, y) n= 1 + n= M 1 + hn ( x, y) f f n= 1 *

61 Comments Note the Lebesgue number only depends on the distribution of nodes. The only condition on the function being approximated is that it is continuous. p Here s the tricky part. It is difficult to compute Λ exactly as it requires us to search the continuum of points in the triangle. However, we can approximate this number by randomly sampling a large number of points in the triangle. i.e. for some, large, N compute the following: p Λ = i= M j= 1,.., N i = 1 ( ) max h x, y i j j {( )} j j for some finite subset x, y T j= 1,.., N

62 Open Problem It is still an open problem to find the set of nodes for the triangle which minimize the Lebesgue constant. Various attempts have been made: Hesthaven: (You will need access permission so download on on campus) Wingate and Taylor: And others.. See comparison tables in Hesthaven paper.

63 Next Class We will assume one type of these sets of nodes is being used and will go on to discuss how we can perform necessary manipulations (integration, differentiation, interpolation) with data at these nodes. We will then introduce the discontinuous Galerkin method, and show how we can achieve p th order accurate numerical solutions when the actual solution is sufficiently smooth. Furthermore, we will see how boundary conditions are straight forward to implement in contrast the finite difference methods we saw previously.

Numerical Methods for Partial Differential Equations. CAAM 452 Spring 2005 Lecture 2 Instructor: Tim Warburton

Numerical Methods for Partial Differential Equations. CAAM 452 Spring 2005 Lecture 2 Instructor: Tim Warburton Numerical Methods for Partial Differential Equations CAAM 452 Spring 2005 Lecture 2 Instructor: Tim Warburton Note on textbook for finite difference methods Due to the difficulty some students have experienced

More information

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

Introduction. J.M. Burgers Center Graduate Course CFD I January Least-Squares Spectral Element Methods Introduction In this workshop we will introduce you to the least-squares spectral element method. As you can see from the lecture notes, this method is a combination of the weak formulation derived from

More information

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

Finite Elements. Colin Cotter. January 15, Colin Cotter FEM Finite Elements January 15, 2018 Why Can solve PDEs on complicated domains. Have flexibility to increase order of accuracy and match the numerics to the physics. has an elegant mathematical formulation

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

Numerical Methods for Partial Differential Equations. CAAM 452 Spring 2005 Lecture 3 AB2,AB3, Stability, Accuracy Instructor: Tim Warburton

Numerical Methods for Partial Differential Equations. CAAM 452 Spring 2005 Lecture 3 AB2,AB3, Stability, Accuracy Instructor: Tim Warburton Numerical Methods for Partial Differential Equations CAAM 452 Spring 25 Lecture 3 AB2,AB3, Stability, Accuracy Instructor: Tim Warburton Recall: Euler-Forward Time Stepping By several different approximations

More information

We have been going places in the car of calculus for years, but this analysis course is about how the car actually works.

We have been going places in the car of calculus for years, but this analysis course is about how the car actually works. Analysis I We have been going places in the car of calculus for years, but this analysis course is about how the car actually works. Copier s Message These notes may contain errors. In fact, they almost

More information

Power series and Taylor series

Power series and Taylor series Power series and Taylor series D. DeTurck University of Pennsylvania March 29, 2018 D. DeTurck Math 104 002 2018A: Series 1 / 42 Series First... a review of what we have done so far: 1 We examined series

More information

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation Lecture slides based on the textbook Scientific Computing: An Introductory Survey by Michael T. Heath, copyright c 2018 by the Society for Industrial and Applied Mathematics. http://www.siam.org/books/cl80

More information

Math (P)Review Part II:

Math (P)Review Part II: Math (P)Review Part II: Vector Calculus Computer Graphics Assignment 0.5 (Out today!) Same story as last homework; second part on vector calculus. Slightly fewer questions Last Time: Linear Algebra Touched

More information

Some Background Material

Some Background Material Chapter 1 Some Background Material In the first chapter, we present a quick review of elementary - but important - material as a way of dipping our toes in the water. This chapter also introduces important

More information

We denote the space of distributions on Ω by D ( Ω) 2.

We denote the space of distributions on Ω by D ( Ω) 2. Sep. 1 0, 008 Distributions Distributions are generalized functions. Some familiarity with the theory of distributions helps understanding of various function spaces which play important roles in the study

More information

MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS NUMERICAL FLUID MECHANICS FALL 2011

MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS NUMERICAL FLUID MECHANICS FALL 2011 MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS 02139 2.29 NUMERICAL FLUID MECHANICS FALL 2011 QUIZ 2 The goals of this quiz 2 are to: (i) ask some general

More information

Page 404. Lecture 22: Simple Harmonic Oscillator: Energy Basis Date Given: 2008/11/19 Date Revised: 2008/11/19

Page 404. Lecture 22: Simple Harmonic Oscillator: Energy Basis Date Given: 2008/11/19 Date Revised: 2008/11/19 Page 404 Lecture : Simple Harmonic Oscillator: Energy Basis Date Given: 008/11/19 Date Revised: 008/11/19 Coordinate Basis Section 6. The One-Dimensional Simple Harmonic Oscillator: Coordinate Basis Page

More information

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

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C. Lecture 9 Approximations of Laplace s Equation, Finite Element Method Mathématiques appliquées (MATH54-1) B. Dewals, C. Geuzaine V1.2 23/11/218 1 Learning objectives of this lecture Apply the finite difference

More information

Lagrange Multipliers

Lagrange Multipliers Optimization with Constraints As long as algebra and geometry have been separated, their progress have been slow and their uses limited; but when these two sciences have been united, they have lent each

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 Nonconformity and the Consistency Error First Strang Lemma Abstract Error Estimate

More information

Chapter 11 - Sequences and Series

Chapter 11 - Sequences and Series Calculus and Analytic Geometry II Chapter - Sequences and Series. Sequences Definition. A sequence is a list of numbers written in a definite order, We call a n the general term of the sequence. {a, a

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

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

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

Divergence Formulation of Source Term

Divergence Formulation of Source Term Preprint accepted for publication in Journal of Computational Physics, 2012 http://dx.doi.org/10.1016/j.jcp.2012.05.032 Divergence Formulation of Source Term Hiroaki Nishikawa National Institute of Aerospace,

More information

Integration, differentiation, and root finding. Phys 420/580 Lecture 7

Integration, differentiation, and root finding. Phys 420/580 Lecture 7 Integration, differentiation, and root finding Phys 420/580 Lecture 7 Numerical integration Compute an approximation to the definite integral I = b Find area under the curve in the interval Trapezoid Rule:

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

The Discontinuous Galerkin Method for Hyperbolic Problems

The Discontinuous Galerkin Method for Hyperbolic Problems Chapter 2 The Discontinuous Galerkin Method for Hyperbolic Problems In this chapter we shall specify the types of problems we consider, introduce most of our notation, and recall some theory on the DG

More information

Basic Concepts of Adaptive Finite Element Methods for Elliptic Boundary Value Problems

Basic Concepts of Adaptive Finite Element Methods for Elliptic Boundary Value Problems Basic Concepts of Adaptive Finite lement Methods for lliptic Boundary Value Problems Ronald H.W. Hoppe 1,2 1 Department of Mathematics, University of Houston 2 Institute of Mathematics, University of Augsburg

More information

An Adaptive Mixed Finite Element Method using the Lagrange Multiplier Technique

An Adaptive Mixed Finite Element Method using the Lagrange Multiplier Technique An Adaptive Mixed Finite Element Method using the Lagrange Multiplier Technique by Michael Gagnon A Project Report Submitted to the Faculty of the WORCESTER POLYTECHNIC INSTITUTE In partial fulfillment

More information

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

Finite Elements. Colin Cotter. January 18, Colin Cotter FEM Finite Elements January 18, 2019 The finite element Given a triangulation T of a domain Ω, finite element spaces are defined according to 1. the form the functions take (usually polynomial) when restricted

More information

Last Update: March 1 2, 201 0

Last Update: March 1 2, 201 0 M ath 2 0 1 E S 1 W inter 2 0 1 0 Last Update: March 1 2, 201 0 S eries S olutions of Differential Equations Disclaimer: This lecture note tries to provide an alternative approach to the material in Sections

More information

Effective Resistance and Schur Complements

Effective Resistance and Schur Complements Spectral Graph Theory Lecture 8 Effective Resistance and Schur Complements Daniel A Spielman September 28, 2015 Disclaimer These notes are not necessarily an accurate representation of what happened in

More information

Preliminary Examination in Numerical Analysis

Preliminary Examination in Numerical Analysis Department of Applied Mathematics Preliminary Examination in Numerical Analysis August 7, 06, 0 am pm. Submit solutions to four (and no more) of the following six problems. Show all your work, and justify

More information

Part 3.3 Differentiation Taylor Polynomials

Part 3.3 Differentiation Taylor Polynomials Part 3.3 Differentiation 3..3.1 Taylor Polynomials Definition 3.3.1 Taylor 1715 and Maclaurin 1742) If a is a fixed number, and f is a function whose first n derivatives exist at a then the Taylor polynomial

More information

43.1 Vector Fields and their properties

43.1 Vector Fields and their properties Module 15 : Vector fields, Gradient, Divergence and Curl Lecture 43 : Vector fields and their properties [Section 43.1] Objectives In this section you will learn the following : Concept of Vector field.

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

Economics 204 Summer/Fall 2011 Lecture 5 Friday July 29, 2011

Economics 204 Summer/Fall 2011 Lecture 5 Friday July 29, 2011 Economics 204 Summer/Fall 2011 Lecture 5 Friday July 29, 2011 Section 2.6 (cont.) Properties of Real Functions Here we first study properties of functions from R to R, making use of the additional structure

More information

we have the following equation:

we have the following equation: 1 VMTS Homework #1 due Thursday, July 6 Exercise 1 In triangle ABC, let P be 2 3 of the way from A to B, let Q be 1 3 of the way from P to C, and let the line BQ intersect AC in R How far is R along the

More information

5 Irreducible representations

5 Irreducible representations Physics 129b Lecture 8 Caltech, 01/1/19 5 Irreducible representations 5.5 Regular representation and its decomposition into irreps To see that the inequality is saturated, we need to consider the so-called

More information

ENGI Gradient, Divergence, Curl Page 5.01

ENGI Gradient, Divergence, Curl Page 5.01 ENGI 94 5. - Gradient, Divergence, Curl Page 5. 5. The Gradient Operator A brief review is provided here for the gradient operator in both Cartesian and orthogonal non-cartesian coordinate systems. Sections

More information

8.5 Taylor Polynomials and Taylor Series

8.5 Taylor Polynomials and Taylor Series 8.5. TAYLOR POLYNOMIALS AND TAYLOR SERIES 50 8.5 Taylor Polynomials and Taylor Series Motivating Questions In this section, we strive to understand the ideas generated by the following important questions:

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

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

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA Introduction to Finite and Spectral Element Methods Using MATLAB Second Edition C. Pozrikidis University of Massachusetts Amherst, USA (g) CRC Press Taylor & Francis Group Boca Raton London New York CRC

More information

Multiple Integrals and Vector Calculus (Oxford Physics) Synopsis and Problem Sets; Hilary 2015

Multiple Integrals and Vector Calculus (Oxford Physics) Synopsis and Problem Sets; Hilary 2015 Multiple Integrals and Vector Calculus (Oxford Physics) Ramin Golestanian Synopsis and Problem Sets; Hilary 215 The outline of the material, which will be covered in 14 lectures, is as follows: 1. Introduction

More information

Newtonian Mechanics. Chapter Classical space-time

Newtonian Mechanics. Chapter Classical space-time Chapter 1 Newtonian Mechanics In these notes classical mechanics will be viewed as a mathematical model for the description of physical systems consisting of a certain (generally finite) number of particles

More information

Worksheet 1.4: Geometry of the Dot and Cross Products

Worksheet 1.4: Geometry of the Dot and Cross Products Boise State Math 275 (Ultman) Worksheet 1.4: Geometry of the Dot and Cross Products From the Toolbox (what you need from previous classes): Basic algebra and trigonometry: be able to solve quadratic equations,

More information

Richard S. Palais Department of Mathematics Brandeis University Waltham, MA The Magic of Iteration

Richard S. Palais Department of Mathematics Brandeis University Waltham, MA The Magic of Iteration Richard S. Palais Department of Mathematics Brandeis University Waltham, MA 02254-9110 The Magic of Iteration Section 1 The subject of these notes is one of my favorites in all mathematics, and it s not

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

Print Your Name: Your Section:

Print Your Name: Your Section: Print Your Name: Your Section: Mathematics 1c. Practice Final Solutions This exam has ten questions. J. Marsden You may take four hours; there is no credit for overtime work No aids (including notes, books,

More information

Ideas from Vector Calculus Kurt Bryan

Ideas from Vector Calculus Kurt Bryan Ideas from Vector Calculus Kurt Bryan Most of the facts I state below are for functions of two or three variables, but with noted exceptions all are true for functions of n variables..1 Tangent Line Approximation

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

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 The Residual and Error of Finite Element Solutions Mixed BVP of Poisson Equation

More information

Math 361: Homework 1 Solutions

Math 361: Homework 1 Solutions January 3, 4 Math 36: Homework Solutions. We say that two norms and on a vector space V are equivalent or comparable if the topology they define on V are the same, i.e., for any sequence of vectors {x

More information

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

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends Lecture 25: Introduction to Discontinuous Galerkin Methods Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Finite Element Methods

More information

COMP 558 lecture 18 Nov. 15, 2010

COMP 558 lecture 18 Nov. 15, 2010 Least squares We have seen several least squares problems thus far, and we will see more in the upcoming lectures. For this reason it is good to have a more general picture of these problems and how to

More information

1 Math 241A-B Homework Problem List for F2015 and W2016

1 Math 241A-B Homework Problem List for F2015 and W2016 1 Math 241A-B Homework Problem List for F2015 W2016 1.1 Homework 1. Due Wednesday, October 7, 2015 Notation 1.1 Let U be any set, g be a positive function on U, Y be a normed space. For any f : U Y let

More information

Sparse Linear Systems. Iterative Methods for Sparse Linear Systems. Motivation for Studying Sparse Linear Systems. Partial Differential Equations

Sparse Linear Systems. Iterative Methods for Sparse Linear Systems. Motivation for Studying Sparse Linear Systems. Partial Differential Equations Sparse Linear Systems Iterative Methods for Sparse Linear Systems Matrix Computations and Applications, Lecture C11 Fredrik Bengzon, Robert Söderlund We consider the problem of solving the linear system

More information

You may not start to read the questions printed on the subsequent pages until instructed to do so by the Invigilator.

You may not start to read the questions printed on the subsequent pages until instructed to do so by the Invigilator. MATHEMATICAL TRIPOS Part IB Thursday 7 June 2007 9 to 12 PAPER 3 Before you begin read these instructions carefully. Each question in Section II carries twice the number of marks of each question in Section

More information

Problem Set Number 01, MIT (Winter-Spring 2018)

Problem Set Number 01, MIT (Winter-Spring 2018) Problem Set Number 01, 18.377 MIT (Winter-Spring 2018) Rodolfo R. Rosales (MIT, Math. Dept., room 2-337, Cambridge, MA 02139) February 28, 2018 Due Thursday, March 8, 2018. Turn it in (by 3PM) at the Math.

More information

Scientific Computing

Scientific Computing 2301678 Scientific Computing Chapter 2 Interpolation and Approximation Paisan Nakmahachalasint Paisan.N@chula.ac.th Chapter 2 Interpolation and Approximation p. 1/66 Contents 1. Polynomial interpolation

More information

U.C. Berkeley CS294: Spectral Methods and Expanders Handout 11 Luca Trevisan February 29, 2016

U.C. Berkeley CS294: Spectral Methods and Expanders Handout 11 Luca Trevisan February 29, 2016 U.C. Berkeley CS294: Spectral Methods and Expanders Handout Luca Trevisan February 29, 206 Lecture : ARV In which we introduce semi-definite programming and a semi-definite programming relaxation of sparsest

More information

Kasetsart University Workshop. Multigrid methods: An introduction

Kasetsart University Workshop. Multigrid methods: An introduction Kasetsart University Workshop Multigrid methods: An introduction Dr. Anand Pardhanani Mathematics Department Earlham College Richmond, Indiana USA pardhan@earlham.edu A copy of these slides is available

More information

x x2 2 + x3 3 x4 3. Use the divided-difference method to find a polynomial of least degree that fits the values shown: (b)

x x2 2 + x3 3 x4 3. Use the divided-difference method to find a polynomial of least degree that fits the values shown: (b) Numerical Methods - PROBLEMS. The Taylor series, about the origin, for log( + x) is x x2 2 + x3 3 x4 4 + Find an upper bound on the magnitude of the truncation error on the interval x.5 when log( + x)

More information

Integration in the Complex Plane (Zill & Wright Chapter 18)

Integration in the Complex Plane (Zill & Wright Chapter 18) Integration in the omplex Plane Zill & Wright hapter 18) 116-4-: omplex Variables Fall 11 ontents 1 ontour Integrals 1.1 Definition and Properties............................. 1. Evaluation.....................................

More information

Discontinuous Galerkin Methods

Discontinuous Galerkin Methods Discontinuous Galerkin Methods Joachim Schöberl May 20, 206 Discontinuous Galerkin (DG) methods approximate the solution with piecewise functions (polynomials), which are discontinuous across element interfaces.

More information

Conservation Laws & Applications

Conservation Laws & Applications Rocky Mountain Mathematics Consortium Summer School Conservation Laws & Applications Lecture V: Discontinuous Galerkin Methods James A. Rossmanith Department of Mathematics University of Wisconsin Madison

More information

Inner product spaces. Layers of structure:

Inner product spaces. Layers of structure: Inner product spaces Layers of structure: vector space normed linear space inner product space The abstract definition of an inner product, which we will see very shortly, is simple (and by itself is pretty

More information

4. Numerical Quadrature. Where analytical abilities end... continued

4. Numerical Quadrature. Where analytical abilities end... continued 4. Numerical Quadrature Where analytical abilities end... continued Where analytical abilities end... continued, November 30, 22 1 4.3. Extrapolation Increasing the Order Using Linear Combinations Once

More information

Lecture 2: Review of Prerequisites. Table of contents

Lecture 2: Review of Prerequisites. Table of contents Math 348 Fall 217 Lecture 2: Review of Prerequisites Disclaimer. As we have a textbook, this lecture note is for guidance and supplement only. It should not be relied on when preparing for exams. In this

More information

Orthogonality of hat functions in Sobolev spaces

Orthogonality of hat functions in Sobolev spaces 1 Orthogonality of hat functions in Sobolev spaces Ulrich Reif Technische Universität Darmstadt A Strobl, September 18, 27 2 3 Outline: Recap: quasi interpolation Recap: orthogonality of uniform B-splines

More information

Finite Volume Method for Scalar Advection in 2D

Finite Volume Method for Scalar Advection in 2D Chapter 9 Finite Volume Method for Scalar Advection in D 9. Introduction The purpose of this exercise is to code a program to integrate the scalar advection equation in two-dimensional flows. 9. The D

More information

Lecture 3: Vectors. In Song Kim. September 1, 2011

Lecture 3: Vectors. In Song Kim. September 1, 2011 Lecture 3: Vectors In Song Kim September 1, 211 1 Solving Equations Up until this point we have been looking at different types of functions, often times graphing them. Each point on a graph is a solution

More information

One Dimensional Convection: Interpolation Models for CFD

One Dimensional Convection: Interpolation Models for CFD One Dimensional Convection: Interpolation Models for CFD ME 448/548 Notes Gerald Recktenwald Portland State University Department of Mechanical Engineering gerry@pdx.edu ME 448/548: 1D Convection-Diffusion

More information

Lecture 20: Lagrange Interpolation and Neville s Algorithm. for I will pass through thee, saith the LORD. Amos 5:17

Lecture 20: Lagrange Interpolation and Neville s Algorithm. for I will pass through thee, saith the LORD. Amos 5:17 Lecture 20: Lagrange Interpolation and Neville s Algorithm for I will pass through thee, saith the LORD. Amos 5:17 1. Introduction Perhaps the easiest way to describe a shape is to select some points on

More information

Lecture 4: Numerical solution of ordinary differential equations

Lecture 4: Numerical solution of ordinary differential equations Lecture 4: Numerical solution of ordinary differential equations Department of Mathematics, ETH Zürich General explicit one-step method: Consistency; Stability; Convergence. High-order methods: Taylor

More information

2t t dt.. So the distance is (t2 +6) 3/2

2t t dt.. So the distance is (t2 +6) 3/2 Math 8, Solutions to Review for the Final Exam Question : The distance is 5 t t + dt To work that out, integrate by parts with u t +, so that t dt du The integral is t t + dt u du u 3/ (t +) 3/ So the

More information

Chapter 4. Two-Dimensional Finite Element Analysis

Chapter 4. Two-Dimensional Finite Element Analysis Chapter 4. Two-Dimensional Finite Element Analysis general two-dimensional boundary-value problems 4.1 The Boundary-Value Problem 2nd-order differential equation to consider α α β φ Ω (4.1) Laplace, Poisson

More information

Introduction to Partial Differential Equations

Introduction to Partial Differential Equations Introduction to Partial Differential Equations Partial differential equations arise in a number of physical problems, such as fluid flow, heat transfer, solid mechanics and biological processes. These

More information

4 Uniform convergence

4 Uniform convergence 4 Uniform convergence In the last few sections we have seen several functions which have been defined via series or integrals. We now want to develop tools that will allow us to show that these functions

More information

AProofoftheStabilityoftheSpectral Difference Method For All Orders of Accuracy

AProofoftheStabilityoftheSpectral Difference Method For All Orders of Accuracy AProofoftheStabilityoftheSpectral Difference Method For All Orders of Accuracy Antony Jameson 1 1 Thomas V. Jones Professor of Engineering Department of Aeronautics and Astronautics Stanford University

More information

Finite difference models: one dimension

Finite difference models: one dimension Chapter 6 Finite difference models: one dimension 6.1 overview Our goal in building numerical models is to represent differential equations in a computationally manageable way. A large class of numerical

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 7 Interpolation Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002. Reproduction permitted

More information

Multiple Integrals and Vector Calculus: Synopsis

Multiple Integrals and Vector Calculus: Synopsis Multiple Integrals and Vector Calculus: Synopsis Hilary Term 28: 14 lectures. Steve Rawlings. 1. Vectors - recap of basic principles. Things which are (and are not) vectors. Differentiation and integration

More information

We wish to solve a system of N simultaneous linear algebraic equations for the N unknowns x 1, x 2,...,x N, that are expressed in the general form

We wish to solve a system of N simultaneous linear algebraic equations for the N unknowns x 1, x 2,...,x N, that are expressed in the general form Linear algebra This chapter discusses the solution of sets of linear algebraic equations and defines basic vector/matrix operations The focus is upon elimination methods such as Gaussian elimination, and

More information

Notions such as convergent sequence and Cauchy sequence make sense for any metric space. Convergent Sequences are Cauchy

Notions such as convergent sequence and Cauchy sequence make sense for any metric space. Convergent Sequences are Cauchy Banach Spaces These notes provide an introduction to Banach spaces, which are complete normed vector spaces. For the purposes of these notes, all vector spaces are assumed to be over the real numbers.

More information

OR MSc Maths Revision Course

OR MSc Maths Revision Course OR MSc Maths Revision Course Tom Byrne School of Mathematics University of Edinburgh t.m.byrne@sms.ed.ac.uk 15 September 2017 General Information Today JCMB Lecture Theatre A, 09:30-12:30 Mathematics revision

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

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

Outline. 1 Interpolation. 2 Polynomial Interpolation. 3 Piecewise Polynomial Interpolation

Outline. 1 Interpolation. 2 Polynomial Interpolation. 3 Piecewise Polynomial Interpolation Outline Interpolation 1 Interpolation 2 3 Michael T. Heath Scientific Computing 2 / 56 Interpolation Motivation Choosing Interpolant Existence and Uniqueness Basic interpolation problem: for given data

More information

3 Applications of partial differentiation

3 Applications of partial differentiation Advanced Calculus Chapter 3 Applications of partial differentiation 37 3 Applications of partial differentiation 3.1 Stationary points Higher derivatives Let U R 2 and f : U R. The partial derivatives

More information

QM and Angular Momentum

QM and Angular Momentum Chapter 5 QM and Angular Momentum 5. Angular Momentum Operators In your Introductory Quantum Mechanics (QM) course you learned about the basic properties of low spin systems. Here we want to review that

More information

7 PDES, FOURIER SERIES AND TRANSFORMS Last Updated: July 16, 2012

7 PDES, FOURIER SERIES AND TRANSFORMS Last Updated: July 16, 2012 Problem List 7.1 Fourier series expansion of absolute value function 7.2 Fourier series expansion of step function 7.3 Orthogonality of functions 7.4 Fourier transform of sinusoidal pulse 7.5 Introducing

More information

The Convergence of Mimetic Discretization

The Convergence of Mimetic Discretization The Convergence of Mimetic Discretization for Rough Grids James M. Hyman Los Alamos National Laboratory T-7, MS-B84 Los Alamos NM 87545 and Stanly Steinberg Department of Mathematics and Statistics University

More information

We are going to discuss what it means for a sequence to converge in three stages: First, we define what it means for a sequence to converge to zero

We are going to discuss what it means for a sequence to converge in three stages: First, we define what it means for a sequence to converge to zero Chapter Limits of Sequences Calculus Student: lim s n = 0 means the s n are getting closer and closer to zero but never gets there. Instructor: ARGHHHHH! Exercise. Think of a better response for the instructor.

More information

APPENDIX A. Background Mathematics. A.1 Linear Algebra. Vector algebra. Let x denote the n-dimensional column vector with components x 1 x 2.

APPENDIX A. Background Mathematics. A.1 Linear Algebra. Vector algebra. Let x denote the n-dimensional column vector with components x 1 x 2. APPENDIX A Background Mathematics A. Linear Algebra A.. Vector algebra Let x denote the n-dimensional column vector with components 0 x x 2 B C @. A x n Definition 6 (scalar product). The scalar product

More information

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

INDEX. Bolzano-Weierstrass theorem, for sequences, boundary points, bounded functions, 142 bounded sets, 42 43 INDEX Abel s identity, 131 Abel s test, 131 132 Abel s theorem, 463 464 absolute convergence, 113 114 implication of conditional convergence, 114 absolute value, 7 reverse triangle inequality, 9 triangle

More information

REVIEW: The Matching Method Algorithm

REVIEW: The Matching Method Algorithm Lecture 26: Numerov Algorithm for Solving the Time-Independent Schrödinger Equation 1 REVIEW: The Matching Method Algorithm Need for a more general method The shooting method for solving the time-independent

More information

MATH2071: LAB #5: Norms, Errors and Condition Numbers

MATH2071: LAB #5: Norms, Errors and Condition Numbers MATH2071: LAB #5: Norms, Errors and Condition Numbers 1 Introduction Introduction Exercise 1 Vector Norms Exercise 2 Matrix Norms Exercise 3 Compatible Matrix Norms Exercise 4 More on the Spectral Radius

More information

Numerical Methods for Inverse Kinematics

Numerical Methods for Inverse Kinematics Numerical Methods for Inverse Kinematics Niels Joubert, UC Berkeley, CS184 2008-11-25 Inverse Kinematics is used to pose models by specifying endpoints of segments rather than individual joint angles.

More information

PDEs, part 1: Introduction and elliptic PDEs

PDEs, part 1: Introduction and elliptic PDEs PDEs, part 1: Introduction and elliptic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2013 Partial di erential equations The solution depends on several variables,

More information

Calculus (Real Analysis I)

Calculus (Real Analysis I) Calculus (Real Analysis I) (MAT122β) Department of Mathematics University of Ruhuna A.W.L. Pubudu Thilan Department of Mathematics University of Ruhuna Calculus (Real Analysis I)(MAT122β) 1/172 Chapter

More information

First, Second, and Third Order Finite-Volume Schemes for Diffusion

First, Second, and Third Order Finite-Volume Schemes for Diffusion First, Second, and Third Order Finite-Volume Schemes for Diffusion Hiro Nishikawa 51st AIAA Aerospace Sciences Meeting, January 10, 2013 Supported by ARO (PM: Dr. Frederick Ferguson), NASA, Software Cradle.

More information

The Particle in a Box

The Particle in a Box Page 324 Lecture 17: Relation of Particle in a Box Eigenstates to Position and Momentum Eigenstates General Considerations on Bound States and Quantization Continuity Equation for Probability Date Given:

More information