Finite Volume Discretization of the Heat Equation

Size: px
Start display at page:

Download "Finite Volume Discretization of the Heat Equation"

Transcription

1 Lecture Notes 3 Finite Volume Discretization of te Heat Equation We consider finite volume discretizations of te one-dimensional variable coefficient eat equation, wit Neumann boundary conditions u t x (k(x) x u) = S(t, x), 0 < x <, t > 0, () Te coefficient k(x) is strictly positive. u(0, x) = f(x), 0 < x <, u x (t, 0) = u x (t, ) = 0, t 0. Semi-discrete approximation By semi-discretization we mean discretization only in space, not in time. Tis approac is also called metod of lines. Discretization We discretize space into N equal size grid cells (bins) of size = /N, and define x j = /2 + j, so tat x j is te center of cell j, see figure. Te edges of cell j are ten and x j+/2. x 0 x x N Unknowns In a finite volume metod te unknowns approximate te average of te solution over a grid cell. More precisely, we let q j (t) be te approximation q j (t) u j (t) := u(t, x)dx. Note te contrast wit finite difference metods, were pointwise values are approximated, and finite element metods, were basis function coefficients are approximated. (0)

2 Exact update formula We derive an exact update formula for u j (t), te exact local averages. Integrating () over cell j and dividing by we get u t (t, x)dx = Upon defining te flux and te local average of te source we get te exact update formula du j (t) x (k(x) x u)dx + S(t, x)dx = k(x j+/2)u x (t, x j+/2 ) k( )u x (t, ) = F j+/2(t) F j /2 (t) F j (t) = F (t, x j ) = k(x j )u x (t, x j ), S j (t) = + S j (t). S(t, x)dx, Te fluxes F j+/2 and F j /2 ten represents ow muc eat flows out troug te left and rigt boundary of te cell. Note, tis is an instance te conservation law in integral form, d V udv + S F nds = V SdV, were we ave picked V as te interval [, x j+/2 ], and scaled by V =. Approximation of te flux + S(t, x)dx. To use te exact update formula as te basis for a numerical sceme we must approximate te fluxes F j±/2. Since te value in te midpoint of te cell is a second order approximation of te average, we ave for smoot u, F j /2 (t) = k( )u x (t, ) = k( ) u(t, x j) u(t, x j ) = k( ) u j(t) u j (t) + O( 2 ). + O( 2 ) We terefore use F j /2 (t) F j /2 (t) = k( ) q j(t) q j (t). as approximation. Tis leads to te numerical sceme for inner points j N 2, dq j (t) F j+/2 (t) F j /2 (t) = + S j (t) (2) = k(x j+/2)(q j+ (t) q j (t)) k( )(q j (t) q j (t)) 2 + S j (t). 2 (0)

3 Hence, wit k j := k(x j ), dq j = k j+/2q j+ (k j+/2 + k j /2 )q j + k j /2 q j 2 + S j, (3) for j =,..., N 2. Tis is a second order approximation. Boundary conditions To complete te sceme (3) we need update formulae also for te boundary points j = 0 and j = N. Tese must be derived by taking te boundary conditions into account. We introduce te gost cells j = and j = N wic are located just outside te domain. Te boundary conditions are used to fill tese cells wit values q and q N, based on te values q j in te interior cells. Te same update formula (3) as before can ten be used also for j = 0 and j = N. Let us consider our boundary condition u x = 0 at x = 0. (We can also tink of tis as a "no flux" condition, F = 0.) We formally extend te definition of te solution u for x < 0, i.e. outside te domain, and, as before, approximate 0 = u x (t, 0) = u(t, x 0) u(t, x ) + O( 2 ) = u 0(t) u (t) + O( 2 ) u (t) = u 0 (t) + O( 3 ). Replacing u j by our approximation q j and dropping te O( 2 ) term we get an expression for q in terms of q 0 as te boundary rule q (t) = q 0 (t). We now insert tis into te update formula (3) for j = 0, dq 0 = k /2q (k /2 + k /2 )q 0 + k /2 q 2 + S 0 = k /2 q q S 0. (4) In exactly te same way we obtain for j = N tat q N (t) = q N (t) and terefore dq N = k N 3/2 q N 2 q N 2 + S N. (5) Remark Diriclet boundary conditions u(t, 0) = u(t, ) = 0 can be approximated to second order in two ways. First, one can use a sifted grid, x j = j so tat x 0 and x N, te centers of cells 0 and N, are precisely on te boundary. Ten one does not need gost cells; one just sets q 0 = q N = 0. Note tat te number of unknows are now only N, so A R (N ) (N ) etc. Second, one can take te average of two cells to approximate te value in between, 0 = u(t, 0) = u(t, x 0) + u(t, x ) 2 leading to te approximations + O( 2 ) = u 0(t) + u (t) 2 q = q 0, q N = q N. + O( 2 ), 3 (0)

4 Matrix form We put all te formulae (3), (4), (5) togeter and write tem in matrix form. Introduce q = and k /2 k /2 A = 2 q 0. q N, S = S 0. S N k /2 (k /2 + k 3/2 ) k 3/ Ten we get te linear ODE system, q, S R k N 5/2 (k N 5/2 + k N 3/2 ) k N 3/2 k N 3/2 k N 3/2 dq(t) R N N. (6) = Aq(t) + S(t). (7) Hence, in tis semi-discretization te time-dependent PDE as been approximated by a system of ODEs, were te matrix A is a discrete approximation of te second order differential operator x k(x) x, including its boundary conditions.. Brief outline of extensions to 2D Te same strategy can be used in 2D. We give a cursory description of te main steps ere. To simplify tings we consider te constant coefficient problem, u t u = S(t, x, y), 0 < x <, 0 < y <, t > 0, u(0, x, y) = f(x, y), 0 < x <, 0 < y <, u x (t, 0, y) = u x (t, 2π, y) = u y (t, x, 0) = u y (t, x, 2π) = 0, 0 < x <, 0 < y <, t 0. Discretization We discretize te domain [0, ] 2 into N N equal size grid cells of size, were = /N. We define x j = /2 + j and y k = /2 + k and denote te cell wit center (x j, y k ) by I jk. 4 (0)

5 y N I jk y y 0 x 0 x x N Unknowns Te unknowns are now q jk (t), wic are approximations of te average of te solution over te grid cell I jk, q jk (t) u jk (t) := 2 I jk u(t, x, y)dxdy. Exact update formula Te update formula is again an instance of te conservation law in integral form were we pick te volume V as I jk and scale by I jk = 2, d 2 udxdy + F nds = I jk 2 I jk 2 Sdxdy, I jk were F = u. Upon defining S jk (t) := 2 I jk S(t, x, y)dxdy, tis can be written as du jk (t) = 2 I jk F nds + Sjk (t). Let F = (f, f 2 ) and define te average flux troug eac side of te cell, F j,k±/2 (t) := we get te exact formula f 2 (t, x, y k±/2 )dx, F j±/2,k (t) := yk+/2 y k /2 f (t, x j±/2, y)dy, du jk = (F j+/2,k F j /2,k + F j,k+/2 F j,k /2 ) + S jk. (8) 5 (0)

6 Again, te fluxes F j,k±/2 and F j±/2,k represent te eat flux (upto sign) out troug te four sides of te cell. Approximation of te flux We use te same type of approximation as in D for F = u. We get for instance F j,k /2 = = 2 u y (t, x, y k /2 )dx = u(t, x, y k )dx + 2 = 3 I jk u(t, x, y)dxdy + 3 = u jk + u j,k + O( 2 ). u(t, x, y k ) u(t, x, y k ) u(t, x, y k )dx + O( 2 ) I j,k u(t, x, y)dxdy + O( 2 ) dx + O( 2 ) Replacing u jk by q jk, dropping O( 2 ) and inserting in te exact formula (8) we get te five-point formula, dq jk = 2 (q j+,k + q j,k + q j,k+ + q j,k 4q jk ) + S jk. Boundary conditions is done as in D. Te matrix form is more complicated and te subject of Homework. 2 Properties of te semi-discrete approximation 2. Conservation Wen S = 0 in () we ave seen tat te solution as te conservation property 0 u(t, x)dx = constant = 0 f(x)dx. In fact tis olds for all conservation laws wit "no-flux" boundary conditions F = 0, wic is easily seen from te integral form of te PDE. An analogue of tis olds also for te semi-discrete approximation. More precisely, let us define Ten Q(t) = N q j (t). Q(t) = constant. (9) Moreover, if we start te approximation wit exact values, q j (0) = u j (0), ten it follows tat Q(t) is exactly te integral of te solution u for all time, Q(t) = constant = Q(0) = N u j (0) = N We prove te exact discrete conservation (9) in two ways. 6 (0) u(0, x)dx = 0 u(0, x)dx = 0 u(t, x)dx.

7 Recall from (2) tat wen S = 0, Ten N dq = dq j (t) N dq j = F j+/2 (t) F j /2 (t) =. (0) F j /2 (t) F j+/2 = F /2 F N /2 = 0, were we used te boundary conditions (4) and (5) wic implies tat F /2 = k /2 q 0 q = 0, FN /2 = k N /2 q N q N Note tat tis discrete conservation property is true for any discretization of te type (0) if F /2 = F N /2, regardless of ow te fluxes F j±/2 are computed. Recall from (7) tat wen S = 0, Moreover, dq(t) = Aq(t). Q(t) = T q, =. RN. Ten dq(t) = T dq(t) = T Aq(t) = 0, since T Aq(t) = (A) T q(t) by te symmetry of A and A are te row sums of A wic are zero, by (6). 2.2 Maximum principle We ave seen before tat in te continuous case tat wen S = 0 in (), te maximum value of te solution u(t, x) in [0, T ] [0, ] is eiter attained on te boundary x {0, } or for te initial data at t = 0 (regardless of boundary conditions). Te corresponding result in te semi-discrete case says tat q = max sup q j (t) j 0,...,N 0 t<t is attained eiter for j = 0, j = N or for te initial data t = 0. Tis is easily sown by contradiction. Suppose te maximum is attained at t = t > 0 and tat it is strictly larger tan q 0 (t ) and q N (t ). Ten, tere must be an interior index j [, N 2] suc tat Terefore dq j (t ) q j (t ) < q j (t ), q j (t ) q j +(t ). = k j +/2 (q j + q j ) }{{} 0 k j /2 (q j q j ) < 0. }{{} >0 Hence, tere is an ε suc tat q j (t) > q j (t ) for all t (t ε, t ), wic contradicts te assumption tat q j (t ) is a maximum. Furtermore, as in te continuous case local spatial maximum (minimum) of q j in te interior cannot increase (decrease) in time. = 0. 7 (0)

8 Forward Euler Im Backward Euler Im D D Re Re Figure. Stability regions D for te Forward and Backward Euler metods. 3 Fully discrete approximation Te semi-discrete approximation leads to a system of ODEs. dq(t) = Aq(t) + S(t). () Tis can be solved by standard numerical metods for ODEs wit a time step t, e.g. Forward Euler metod u n+ = u n + tf(t n, u n ), t n = n t. Applied to () tis would give te fully discrete sceme for (), q n+ = q n + t[aq n + S(t n )], q n q(t n ). As for any ODE metod we must verify its absolute stability: tat for our coice of step size t te tλ k D, k, were D is te stability region of te ODE solver and {λ k } are te eigenvalues of A. For parabolic problems te real part of te eigenvalues are negative, and te size of tem in general grow as / 2. Tis is a major difficulty. It means tat wen te stability region D is bounded, as in explicit metods, we get a time step restriction of te type t C 2. Tis is a severe restriction, wic is seldom warranted from an accuracy point of view. It leads to unnecessarily expensive metods. Example In te constant coefficient case k(x) te eigenvalues of A are precisely λ k = 4 ( ) kπ 2 sin2, k = 0,..., N. 2 Tis gives te stability condition t 2 /2 for Forward Euler. 8 (0)

9 Te underlying reason for te severe time-step restriction is te fact tat parabolic problems include processes on all time-scales: ig frequencies decay fast, low frequencies slowly. Teir semi-discretization ave time-scales spread out all over te interval [ / 2, 0], wic means tat te ODEs are stiff. Te consequence is tat implicit metods sould be used for parabolic problems. Implicit metods typically ave unbounded stability domains D and ave no stability restriction on te time-step tey are unconditionally stable. Of course, implicit metods are more expensive per time-step tan explicit metods, since a system of equations must be solved, but tis is outweiged by te fact tat muc longer time-steps can be taken. Moreover, w en te coefficients do not vary wit time, matrices etc. can be constructed once, and re-factored only as canges of time-step make it necessary. Te "θ-metod" is a class of ODE metods defined as u n+ = u n + t [ θf(t n+, u n+ ) + ( θ)f(t n, u n ) ], 0 θ. Tis includes some common metods: Applied to () we ave or θ = 0 Forward Euler (explicit, st order), θ = /2 Crank Nicolson (implicit, 2nd order), θ = Backward Euler (implicit, st order), q n+ = q n + ta[θq n+ + ( θ)q n ] + t [θs(t n+ ) + ( θ)s(t n )], (2) }{{} S n θ ( θ ta)q n+ = ( + ( θ) ta)q n + ts n θ. For te constant coefficient problem k one can sow te time-step restriction t 2 { 2( 2θ), θ < /2,, /2 θ, (unconditionally stable). Remark 2 Te Crank-Nicolson sceme is second order accurate but gives slowly decaying oscillations for large eigenvalues. It is unsuitable for parabolic problems wit rapidly decaying transients. Te θ = sceme damps all components, and sould be used in te initial steps. Remark 3 Te most used family of time-stepping scemes for parabolic problems are te Backward Differentiation Formulas (BDF), of order troug 5 wic are A(α)-stable. Tey are multistep metods generalizing Backward Euler to iger order. For instance, te second order BDF metod is u n+ = 4 3 un 3 un tf(t n+, u n+ ). BDF metods are also known as Gear s metods and available in Matlab as ODE5S. 3. Fully discrete conservation For te θ-metod we also ave discrete conservation wen S 0. Let Q n N q n j = T q n. 9 (0)

10 Ten upon multiplying by from te left in (2) we get Q n+ = T q n+ = T q n + t T A[θq n+ +( θ)q n ] = Q n + t(a) T [θq n+ +( θ)q n ] = Q n, since as before A = 0. In particular, if initial data is exact, q 0 j = u j(0), ten Q n = 0 u(t n, x)dx, for all n 0. Te same is true for te second order BDF metod if te initialization of te first step Q is conservative so tat Q = Q 0. Ten q n+ = 4 3 qn 3 qn taqn+ implies Q n+ = T q n+ = 4 3 T q n 3 T q n T taq n+ = 4 3 Qn 3 Qn. Wit te stipulated initial data tis difference equation as te solution Q n = Q 0 for all n 0. 4 Acknowledgement Part of tese notes are based on earlier notes by Prof. Jesper Oppelstrup. 0 (0)

Verifying Numerical Convergence Rates

Verifying Numerical Convergence Rates 1 Order of accuracy Verifying Numerical Convergence Rates We consider a numerical approximation of an exact value u. Te approximation depends on a small parameter, suc as te grid size or time step, and

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

Instantaneous Rate of Change:

Instantaneous Rate of Change: Instantaneous Rate of Cange: Last section we discovered tat te average rate of cange in F(x) can also be interpreted as te slope of a scant line. Te average rate of cange involves te cange in F(x) over

More information

Lecture 10: What is a Function, definition, piecewise defined functions, difference quotient, domain of a function

Lecture 10: What is a Function, definition, piecewise defined functions, difference quotient, domain of a function Lecture 10: Wat is a Function, definition, piecewise defined functions, difference quotient, domain of a function A function arises wen one quantity depends on anoter. Many everyday relationsips between

More information

Derivatives Math 120 Calculus I D Joyce, Fall 2013

Derivatives Math 120 Calculus I D Joyce, Fall 2013 Derivatives Mat 20 Calculus I D Joyce, Fall 203 Since we ave a good understanding of its, we can develop derivatives very quickly. Recall tat we defined te derivative f x of a function f at x to be te

More information

The EOQ Inventory Formula

The EOQ Inventory Formula Te EOQ Inventory Formula James M. Cargal Matematics Department Troy University Montgomery Campus A basic problem for businesses and manufacturers is, wen ordering supplies, to determine wat quantity of

More information

f(a + h) f(a) f (a) = lim

f(a + h) f(a) f (a) = lim Lecture 7 : Derivative AS a Function In te previous section we defined te derivative of a function f at a number a (wen te function f is defined in an open interval containing a) to be f (a) 0 f(a + )

More information

In other words the graph of the polynomial should pass through the points

In other words the graph of the polynomial should pass through the points Capter 3 Interpolation Interpolation is te problem of fitting a smoot curve troug a given set of points, generally as te grap of a function. It is useful at least in data analysis (interpolation is a form

More information

2 Limits and Derivatives

2 Limits and Derivatives 2 Limits and Derivatives 2.7 Tangent Lines, Velocity, and Derivatives A tangent line to a circle is a line tat intersects te circle at exactly one point. We would like to take tis idea of tangent line

More information

MATHEMATICS FOR ENGINEERING DIFFERENTIATION TUTORIAL 1 - BASIC DIFFERENTIATION

MATHEMATICS FOR ENGINEERING DIFFERENTIATION TUTORIAL 1 - BASIC DIFFERENTIATION MATHEMATICS FOR ENGINEERING DIFFERENTIATION TUTORIAL 1 - BASIC DIFFERENTIATION Tis tutorial is essential pre-requisite material for anyone stuing mecanical engineering. Tis tutorial uses te principle of

More information

SAT Subject Math Level 1 Facts & Formulas

SAT Subject Math Level 1 Facts & Formulas Numbers, Sequences, Factors Integers:..., -3, -2, -1, 0, 1, 2, 3,... Reals: integers plus fractions, decimals, and irrationals ( 2, 3, π, etc.) Order Of Operations: Aritmetic Sequences: PEMDAS (Parenteses

More information

Math 113 HW #5 Solutions

Math 113 HW #5 Solutions Mat 3 HW #5 Solutions. Exercise.5.6. Suppose f is continuous on [, 5] and te only solutions of te equation f(x) = 6 are x = and x =. If f() = 8, explain wy f(3) > 6. Answer: Suppose we ad tat f(3) 6. Ten

More information

Geometric Stratification of Accounting Data

Geometric Stratification of Accounting Data Stratification of Accounting Data Patricia Gunning * Jane Mary Horgan ** William Yancey *** Abstract: We suggest a new procedure for defining te boundaries of te strata in igly skewed populations, usual

More information

Tangent Lines and Rates of Change

Tangent Lines and Rates of Change Tangent Lines and Rates of Cange 9-2-2005 Given a function y = f(x), ow do you find te slope of te tangent line to te grap at te point P(a, f(a))? (I m tinking of te tangent line as a line tat just skims

More information

Part II: Finite Difference/Volume Discretisation for CFD

Part II: Finite Difference/Volume Discretisation for CFD Part II: Finite Difference/Volume Discretisation for CFD Finite Volume Metod of te Advection-Diffusion Equation A Finite Difference/Volume Metod for te Incompressible Navier-Stokes Equations Marker-and-Cell

More information

ACT Math Facts & Formulas

ACT Math Facts & Formulas Numbers, Sequences, Factors Integers:..., -3, -2, -1, 0, 1, 2, 3,... Rationals: fractions, tat is, anyting expressable as a ratio of integers Reals: integers plus rationals plus special numbers suc as

More information

6. Differentiating the exponential and logarithm functions

6. Differentiating the exponential and logarithm functions 1 6. Differentiating te exponential and logaritm functions We wis to find and use derivatives for functions of te form f(x) = a x, were a is a constant. By far te most convenient suc function for tis purpose

More information

Chapter 7 Numerical Differentiation and Integration

Chapter 7 Numerical Differentiation and Integration 45 We ave a abit in writing articles publised in scientiþc journals to make te work as Þnised as possible, to cover up all te tracks, to not worry about te blind alleys or describe ow you ad te wrong idea

More information

Sections 3.1/3.2: Introducing the Derivative/Rules of Differentiation

Sections 3.1/3.2: Introducing the Derivative/Rules of Differentiation Sections 3.1/3.2: Introucing te Derivative/Rules of Differentiation 1 Tangent Line Before looking at te erivative, refer back to Section 2.1, looking at average velocity an instantaneous velocity. Here

More information

Theoretical calculation of the heat capacity

Theoretical calculation of the heat capacity eoretical calculation of te eat capacity Principle of equipartition of energy Heat capacity of ideal and real gases Heat capacity of solids: Dulong-Petit, Einstein, Debye models Heat capacity of metals

More information

Can a Lump-Sum Transfer Make Everyone Enjoy the Gains. from Free Trade?

Can a Lump-Sum Transfer Make Everyone Enjoy the Gains. from Free Trade? Can a Lump-Sum Transfer Make Everyone Enjoy te Gains from Free Trade? Yasukazu Icino Department of Economics, Konan University June 30, 2010 Abstract I examine lump-sum transfer rules to redistribute te

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

OPTIMAL DISCONTINUOUS GALERKIN METHODS FOR THE ACOUSTIC WAVE EQUATION IN HIGHER DIMENSIONS

OPTIMAL DISCONTINUOUS GALERKIN METHODS FOR THE ACOUSTIC WAVE EQUATION IN HIGHER DIMENSIONS OPTIMAL DISCONTINUOUS GALERKIN METHODS FOR THE ACOUSTIC WAVE EQUATION IN HIGHER DIMENSIONS ERIC T. CHUNG AND BJÖRN ENGQUIST Abstract. In tis paper, we developed and analyzed a new class of discontinuous

More information

13 PERIMETER AND AREA OF 2D SHAPES

13 PERIMETER AND AREA OF 2D SHAPES 13 PERIMETER AND AREA OF D SHAPES 13.1 You can find te perimeter of sapes Key Points Te perimeter of a two-dimensional (D) sape is te total distance around te edge of te sape. l To work out te perimeter

More information

Note nine: Linear programming CSE 101. 1 Linear constraints and objective functions. 1.1 Introductory example. Copyright c Sanjoy Dasgupta 1

Note nine: Linear programming CSE 101. 1 Linear constraints and objective functions. 1.1 Introductory example. Copyright c Sanjoy Dasgupta 1 Copyrigt c Sanjoy Dasgupta Figure. (a) Te feasible region for a linear program wit two variables (see tet for details). (b) Contour lines of te objective function: for different values of (profit). Te

More information

Determine the perimeter of a triangle using algebra Find the area of a triangle using the formula

Determine the perimeter of a triangle using algebra Find the area of a triangle using the formula Student Name: Date: Contact Person Name: Pone Number: Lesson 0 Perimeter, Area, and Similarity of Triangles Objectives Determine te perimeter of a triangle using algebra Find te area of a triangle using

More information

5.4 The Heat Equation and Convection-Diffusion

5.4 The Heat Equation and Convection-Diffusion 5.4. THE HEAT EQUATION AND CONVECTION-DIFFUSION c 6 Gilbert Strang 5.4 The Heat Equation and Convection-Diffusion The wave equation conserves energy. The heat equation u t = u xx dissipates energy. The

More information

Solving partial differential equations (PDEs)

Solving partial differential equations (PDEs) Solving partial differential equations (PDEs) Hans Fangor Engineering and te Environment University of Soutampton United Kingdom fangor@soton.ac.uk May 3, 2012 1 / 47 Outline I 1 Introduction: wat are

More information

M(0) = 1 M(1) = 2 M(h) = M(h 1) + M(h 2) + 1 (h > 1)

M(0) = 1 M(1) = 2 M(h) = M(h 1) + M(h 2) + 1 (h > 1) Insertion and Deletion in VL Trees Submitted in Partial Fulfillment of te Requirements for Dr. Eric Kaltofen s 66621: nalysis of lgoritms by Robert McCloskey December 14, 1984 1 ackground ccording to Knut

More information

The Derivative as a Function

The Derivative as a Function Section 2.2 Te Derivative as a Function 200 Kiryl Tsiscanka Te Derivative as a Function DEFINITION: Te derivative of a function f at a number a, denoted by f (a), is if tis limit exists. f (a) f(a+) f(a)

More information

1.6. Analyse Optimum Volume and Surface Area. Maximum Volume for a Given Surface Area. Example 1. Solution

1.6. Analyse Optimum Volume and Surface Area. Maximum Volume for a Given Surface Area. Example 1. Solution 1.6 Analyse Optimum Volume and Surface Area Estimation and oter informal metods of optimizing measures suc as surface area and volume often lead to reasonable solutions suc as te design of te tent in tis

More information

Section 3.3. Differentiation of Polynomials and Rational Functions. Difference Equations to Differential Equations

Section 3.3. Differentiation of Polynomials and Rational Functions. Difference Equations to Differential Equations Difference Equations to Differential Equations Section 3.3 Differentiation of Polynomials an Rational Functions In tis section we begin te task of iscovering rules for ifferentiating various classes of

More information

Average and Instantaneous Rates of Change: The Derivative

Average and Instantaneous Rates of Change: The Derivative 9.3 verage and Instantaneous Rates of Cange: Te Derivative 609 OBJECTIVES 9.3 To define and find average rates of cange To define te derivative as a rate of cange To use te definition of derivative to

More information

f(x + h) f(x) h as representing the slope of a secant line. As h goes to 0, the slope of the secant line approaches the slope of the tangent line.

f(x + h) f(x) h as representing the slope of a secant line. As h goes to 0, the slope of the secant line approaches the slope of the tangent line. Derivative of f(z) Dr. E. Jacobs Te erivative of a function is efine as a limit: f (x) 0 f(x + ) f(x) We can visualize te expression f(x+) f(x) as representing te slope of a secant line. As goes to 0,

More information

TRADING AWAY WIDE BRANDS FOR CHEAP BRANDS. Swati Dhingra London School of Economics and CEP. Online Appendix

TRADING AWAY WIDE BRANDS FOR CHEAP BRANDS. Swati Dhingra London School of Economics and CEP. Online Appendix TRADING AWAY WIDE BRANDS FOR CHEAP BRANDS Swati Dingra London Scool of Economics and CEP Online Appendix APPENDIX A. THEORETICAL & EMPIRICAL RESULTS A.1. CES and Logit Preferences: Invariance of Innovation

More information

2.1: The Derivative and the Tangent Line Problem

2.1: The Derivative and the Tangent Line Problem .1.1.1: Te Derivative and te Tangent Line Problem Wat is te deinition o a tangent line to a curve? To answer te diiculty in writing a clear deinition o a tangent line, we can deine it as te iting position

More information

Research on the Anti-perspective Correction Algorithm of QR Barcode

Research on the Anti-perspective Correction Algorithm of QR Barcode Researc on te Anti-perspective Correction Algoritm of QR Barcode Jianua Li, Yi-Wen Wang, YiJun Wang,Yi Cen, Guoceng Wang Key Laboratory of Electronic Tin Films and Integrated Devices University of Electronic

More information

EC201 Intermediate Macroeconomics. EC201 Intermediate Macroeconomics Problem set 8 Solution

EC201 Intermediate Macroeconomics. EC201 Intermediate Macroeconomics Problem set 8 Solution EC201 Intermediate Macroeconomics EC201 Intermediate Macroeconomics Prolem set 8 Solution 1) Suppose tat te stock of mone in a given econom is given te sum of currenc and demand for current accounts tat

More information

The modelling of business rules for dashboard reporting using mutual information

The modelling of business rules for dashboard reporting using mutual information 8 t World IMACS / MODSIM Congress, Cairns, Australia 3-7 July 2009 ttp://mssanz.org.au/modsim09 Te modelling of business rules for dasboard reporting using mutual information Gregory Calbert Command, Control,

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

1 The Collocation Method

1 The Collocation Method CS410 Assignment 7 Due: 1/5/14 (Fri) at 6pm You must wor eiter on your own or wit one partner. You may discuss bacground issues and general solution strategies wit oters, but te solutions you submit must

More information

The finite element immersed boundary method: model, stability, and numerical results

The finite element immersed boundary method: model, stability, and numerical results Te finite element immersed boundary metod: model, stability, and numerical results Lucia Gastaldi Università di Brescia ttp://dm.ing.unibs.it/gastaldi/ INdAM Worksop, Cortona, September 18, 2006 Joint

More information

A Multigrid Tutorial part two

A Multigrid Tutorial part two A Multigrid Tutorial part two William L. Briggs Department of Matematics University of Colorado at Denver Van Emden Henson Center for Applied Scientific Computing Lawrence Livermore National Laboratory

More information

Math Test Sections. The College Board: Expanding College Opportunity

Math Test Sections. The College Board: Expanding College Opportunity Taking te SAT I: Reasoning Test Mat Test Sections Te materials in tese files are intended for individual use by students getting ready to take an SAT Program test; permission for any oter use must be sougt

More information

CHAPTER 8: DIFFERENTIAL CALCULUS

CHAPTER 8: DIFFERENTIAL CALCULUS CHAPTER 8: DIFFERENTIAL CALCULUS 1. Rules of Differentiation As we ave seen, calculating erivatives from first principles can be laborious an ifficult even for some relatively simple functions. It is clearly

More information

Catalogue no. 12-001-XIE. Survey Methodology. December 2004

Catalogue no. 12-001-XIE. Survey Methodology. December 2004 Catalogue no. 1-001-XIE Survey Metodology December 004 How to obtain more information Specific inquiries about tis product and related statistics or services sould be directed to: Business Survey Metods

More information

Warm medium, T H T T H T L. s Cold medium, T L

Warm medium, T H T T H T L. s Cold medium, T L Refrigeration Cycle Heat flows in direction of decreasing temperature, i.e., from ig-temperature to low temperature regions. Te transfer of eat from a low-temperature to ig-temperature requires a refrigerator

More information

Optimized Data Indexing Algorithms for OLAP Systems

Optimized Data Indexing Algorithms for OLAP Systems Database Systems Journal vol. I, no. 2/200 7 Optimized Data Indexing Algoritms for OLAP Systems Lucian BORNAZ Faculty of Cybernetics, Statistics and Economic Informatics Academy of Economic Studies, Bucarest

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

Finite Difference Approach to Option Pricing

Finite Difference Approach to Option Pricing Finite Difference Approach to Option Pricing February 998 CS5 Lab Note. Ordinary differential equation An ordinary differential equation, or ODE, is an equation of the form du = fut ( (), t) (.) dt where

More information

CHAPTER 7. Di erentiation

CHAPTER 7. Di erentiation CHAPTER 7 Di erentiation 1. Te Derivative at a Point Definition 7.1. Let f be a function defined on a neigborood of x 0. f is di erentiable at x 0, if te following it exists: f 0 fx 0 + ) fx 0 ) x 0 )=.

More information

f(x) f(a) x a Our intuition tells us that the slope of the tangent line to the curve at the point P is m P Q =

f(x) f(a) x a Our intuition tells us that the slope of the tangent line to the curve at the point P is m P Q = Lecture 6 : Derivatives and Rates of Cange In tis section we return to te problem of finding te equation of a tangent line to a curve, y f(x) If P (a, f(a)) is a point on te curve y f(x) and Q(x, f(x))

More information

- 1 - Handout #22 May 23, 2012 Huffman Encoding and Data Compression. CS106B Spring 2012. Handout by Julie Zelenski with minor edits by Keith Schwarz

- 1 - Handout #22 May 23, 2012 Huffman Encoding and Data Compression. CS106B Spring 2012. Handout by Julie Zelenski with minor edits by Keith Schwarz CS106B Spring 01 Handout # May 3, 01 Huffman Encoding and Data Compression Handout by Julie Zelenski wit minor edits by Keit Scwarz In te early 1980s, personal computers ad ard disks tat were no larger

More information

SAT Math Facts & Formulas

SAT Math Facts & Formulas Numbers, Sequences, Factors SAT Mat Facts & Formuas Integers:..., -3, -2, -1, 0, 1, 2, 3,... Reas: integers pus fractions, decimas, and irrationas ( 2, 3, π, etc.) Order Of Operations: Aritmetic Sequences:

More information

College Planning Using Cash Value Life Insurance

College Planning Using Cash Value Life Insurance College Planning Using Cas Value Life Insurance CAUTION: Te advisor is urged to be extremely cautious of anoter college funding veicle wic provides a guaranteed return of premium immediately if funded

More information

An inquiry into the multiplier process in IS-LM model

An inquiry into the multiplier process in IS-LM model An inquiry into te multiplier process in IS-LM model Autor: Li ziran Address: Li ziran, Room 409, Building 38#, Peing University, Beijing 00.87,PRC. Pone: (86) 00-62763074 Internet Address: jefferson@water.pu.edu.cn

More information

New Vocabulary volume

New Vocabulary volume -. Plan Objectives To find te volume of a prism To find te volume of a cylinder Examples Finding Volume of a Rectangular Prism Finding Volume of a Triangular Prism 3 Finding Volume of a Cylinder Finding

More information

MATH 4330/5330, Fourier Analysis Section 11, The Discrete Fourier Transform

MATH 4330/5330, Fourier Analysis Section 11, The Discrete Fourier Transform MATH 433/533, Fourier Analysis Section 11, The Discrete Fourier Transform Now, instead of considering functions defined on a continuous domain, like the interval [, 1) or the whole real line R, we wish

More information

Notes: Most of the material in this chapter is taken from Young and Freedman, Chap. 12.

Notes: Most of the material in this chapter is taken from Young and Freedman, Chap. 12. Capter 6. Fluid Mecanics Notes: Most of te material in tis capter is taken from Young and Freedman, Cap. 12. 6.1 Fluid Statics Fluids, i.e., substances tat can flow, are te subjects of tis capter. But

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

Shell and Tube Heat Exchanger

Shell and Tube Heat Exchanger Sell and Tube Heat Excanger MECH595 Introduction to Heat Transfer Professor M. Zenouzi Prepared by: Andrew Demedeiros, Ryan Ferguson, Bradford Powers November 19, 2009 1 Abstract 2 Contents Discussion

More information

Pressure. Pressure. Atmospheric pressure. Conceptual example 1: Blood pressure. Pressure is force per unit area:

Pressure. Pressure. Atmospheric pressure. Conceptual example 1: Blood pressure. Pressure is force per unit area: Pressure Pressure is force per unit area: F P = A Pressure Te direction of te force exerted on an object by a fluid is toward te object and perpendicular to its surface. At a microscopic level, te force

More information

Chapter 10: Refrigeration Cycles

Chapter 10: Refrigeration Cycles Capter 10: efrigeration Cycles Te vapor compression refrigeration cycle is a common metod for transferring eat from a low temperature to a ig temperature. Te above figure sows te objectives of refrigerators

More information

CS 294-73 Software Engineering for Scientific Computing. http://www.cs.berkeley.edu/~colella/cs294fall2013. Lecture 16: Particle Methods; Homework #4

CS 294-73 Software Engineering for Scientific Computing. http://www.cs.berkeley.edu/~colella/cs294fall2013. Lecture 16: Particle Methods; Homework #4 CS 294-73 Software Engineering for Scientific Computing http://www.cs.berkeley.edu/~colella/cs294fall2013 Lecture 16: Particle Methods; Homework #4 Discretizing Time-Dependent Problems From here on in,

More information

Numerical Analysis Lecture Notes

Numerical Analysis Lecture Notes Numerical Analysis Lecture Notes Peter J. Olver. Finite Difference Methods for Partial Differential Equations As you are well aware, most differential equations are much too complicated to be solved by

More information

1 Review of Newton Polynomials

1 Review of Newton Polynomials cs: introduction to numerical analysis 0/0/0 Lecture 8: Polynomial Interpolation: Using Newton Polynomials and Error Analysis Instructor: Professor Amos Ron Scribes: Giordano Fusco, Mark Cowlishaw, Nathanael

More information

1 Finite difference example: 1D implicit heat equation

1 Finite difference example: 1D implicit heat equation 1 Finite difference example: 1D implicit heat equation 1.1 Boundary conditions Neumann and Dirichlet We solve the transient heat equation ρc p t = ( k ) (1) on the domain L/2 x L/2 subject to the following

More information

Numerical Methods for Differential Equations

Numerical Methods for Differential Equations Numerical Methods for Differential Equations Chapter 1: Initial value problems in ODEs Gustaf Söderlind and Carmen Arévalo Numerical Analysis, Lund University Textbooks: A First Course in the Numerical

More information

Solutions by: KARATUĞ OZAN BiRCAN. PROBLEM 1 (20 points): Let D be a region, i.e., an open connected set in

Solutions by: KARATUĞ OZAN BiRCAN. PROBLEM 1 (20 points): Let D be a region, i.e., an open connected set in KOÇ UNIVERSITY, SPRING 2014 MATH 401, MIDTERM-1, MARCH 3 Instructor: BURAK OZBAGCI TIME: 75 Minutes Solutions by: KARATUĞ OZAN BiRCAN PROBLEM 1 (20 points): Let D be a region, i.e., an open connected set

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

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

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

2x + y = 3. Since the second equation is precisely the same as the first equation, it is enough to find x and y satisfying the system

2x + y = 3. Since the second equation is precisely the same as the first equation, it is enough to find x and y satisfying the system 1. Systems of linear equations We are interested in the solutions to systems of linear equations. A linear equation is of the form 3x 5y + 2z + w = 3. The key thing is that we don t multiply the variables

More information

5 Numerical Differentiation

5 Numerical Differentiation D. Levy 5 Numerical Differentiation 5. Basic Concepts This chapter deals with numerical approximations of derivatives. The first questions that comes up to mind is: why do we need to approximate derivatives

More information

ON LOCAL LIKELIHOOD DENSITY ESTIMATION WHEN THE BANDWIDTH IS LARGE

ON LOCAL LIKELIHOOD DENSITY ESTIMATION WHEN THE BANDWIDTH IS LARGE ON LOCAL LIKELIHOOD DENSITY ESTIMATION WHEN THE BANDWIDTH IS LARGE Byeong U. Park 1 and Young Kyung Lee 2 Department of Statistics, Seoul National University, Seoul, Korea Tae Yoon Kim 3 and Ceolyong Park

More information

Strategic trading in a dynamic noisy market. Dimitri Vayanos

Strategic trading in a dynamic noisy market. Dimitri Vayanos LSE Researc Online Article (refereed) Strategic trading in a dynamic noisy market Dimitri Vayanos LSE as developed LSE Researc Online so tat users may access researc output of te Scool. Copyrigt and Moral

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

Unemployment insurance/severance payments and informality in developing countries

Unemployment insurance/severance payments and informality in developing countries Unemployment insurance/severance payments and informality in developing countries David Bardey y and Fernando Jaramillo z First version: September 2011. Tis version: November 2011. Abstract We analyze

More information

Projective Geometry. Projective Geometry

Projective Geometry. Projective Geometry Euclidean versus Euclidean geometry describes sapes as tey are Properties of objects tat are uncanged by rigid motions» Lengts» Angles» Parallelism Projective geometry describes objects as tey appear Lengts,

More information

Schedulability Analysis under Graph Routing in WirelessHART Networks

Schedulability Analysis under Graph Routing in WirelessHART Networks Scedulability Analysis under Grap Routing in WirelessHART Networks Abusayeed Saifulla, Dolvara Gunatilaka, Paras Tiwari, Mo Sa, Cenyang Lu, Bo Li Cengjie Wu, and Yixin Cen Department of Computer Science,

More information

The Dynamics of Movie Purchase and Rental Decisions: Customer Relationship Implications to Movie Studios

The Dynamics of Movie Purchase and Rental Decisions: Customer Relationship Implications to Movie Studios Te Dynamics of Movie Purcase and Rental Decisions: Customer Relationsip Implications to Movie Studios Eddie Ree Associate Professor Business Administration Stoneill College 320 Wasington St Easton, MA

More information

Numerical methods for American options

Numerical methods for American options Lecture 9 Numerical methods for American options Lecture Notes by Andrzej Palczewski Computational Finance p. 1 American options The holder of an American option has the right to exercise it at any moment

More information

How To Ensure That An Eac Edge Program Is Successful

How To Ensure That An Eac Edge Program Is Successful Introduction Te Economic Diversification and Growt Enterprises Act became effective on 1 January 1995. Te creation of tis Act was to encourage new businesses to start or expand in Newfoundland and Labrador.

More information

SAMPLE DESIGN FOR THE TERRORISM RISK INSURANCE PROGRAM SURVEY

SAMPLE DESIGN FOR THE TERRORISM RISK INSURANCE PROGRAM SURVEY ASA Section on Survey Researc Metods SAMPLE DESIG FOR TE TERRORISM RISK ISURACE PROGRAM SURVEY G. ussain Coudry, Westat; Mats yfjäll, Statisticon; and Marianne Winglee, Westat G. ussain Coudry, Westat,

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

MATHEMATICAL MODELS OF LIFE SUPPORT SYSTEMS Vol. I - Mathematical Models for Prediction of Climate - Dymnikov V.P.

MATHEMATICAL MODELS OF LIFE SUPPORT SYSTEMS Vol. I - Mathematical Models for Prediction of Climate - Dymnikov V.P. MATHEMATICAL MODELS FOR PREDICTION OF CLIMATE Institute of Numerical Matematics, Russian Academy of Sciences, Moscow, Russia. Keywords: Modeling, climate system, climate, dynamic system, attractor, dimension,

More information

Mathematics Course 111: Algebra I Part IV: Vector Spaces

Mathematics Course 111: Algebra I Part IV: Vector Spaces Mathematics Course 111: Algebra I Part IV: Vector Spaces D. R. Wilkins Academic Year 1996-7 9 Vector Spaces A vector space over some field K is an algebraic structure consisting of a set V on which are

More information

Writing Mathematics Papers

Writing Mathematics Papers Writing Matematics Papers Tis essay is intended to elp your senior conference paper. It is a somewat astily produced amalgam of advice I ave given to students in my PDCs (Mat 4 and Mat 9), so it s not

More information

Computer Science and Engineering, UCSD October 7, 1999 Goldreic-Levin Teorem Autor: Bellare Te Goldreic-Levin Teorem 1 Te problem We æx a an integer n for te lengt of te strings involved. If a is an n-bit

More information

SAT Math Must-Know Facts & Formulas

SAT Math Must-Know Facts & Formulas SAT Mat Must-Know Facts & Formuas Numbers, Sequences, Factors Integers:..., -3, -2, -1, 0, 1, 2, 3,... Rationas: fractions, tat is, anyting expressabe as a ratio of integers Reas: integers pus rationas

More information

Improved dynamic programs for some batcing problems involving te maximum lateness criterion A P M Wagelmans Econometric Institute Erasmus University Rotterdam PO Box 1738, 3000 DR Rotterdam Te Neterlands

More information

14.1. Basic Concepts of Integration. Introduction. Prerequisites. Learning Outcomes. Learning Style

14.1. Basic Concepts of Integration. Introduction. Prerequisites. Learning Outcomes. Learning Style Basic Concepts of Integration 14.1 Introduction When a function f(x) is known we can differentiate it to obtain its derivative df. The reverse dx process is to obtain the function f(x) from knowledge of

More information

General Framework for an Iterative Solution of Ax b. Jacobi s Method

General Framework for an Iterative Solution of Ax b. Jacobi s Method 2.6 Iterative Solutions of Linear Systems 143 2.6 Iterative Solutions of Linear Systems Consistent linear systems in real life are solved in one of two ways: by direct calculation (using a matrix factorization,

More information

Partial Fractions Examples

Partial Fractions Examples Partial Fractions Examples Partial fractions is the name given to a technique of integration that may be used to integrate any ratio of polynomials. A ratio of polynomials is called a rational function.

More information

Lecture 14: Section 3.3

Lecture 14: Section 3.3 Lecture 14: Section 3.3 Shuanglin Shao October 23, 2013 Definition. Two nonzero vectors u and v in R n are said to be orthogonal (or perpendicular) if u v = 0. We will also agree that the zero vector in

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

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

Compute the derivative by definition: The four step procedure

Compute the derivative by definition: The four step procedure Compute te derivative by definition: Te four step procedure Given a function f(x), te definition of f (x), te derivative of f(x), is lim 0 f(x + ) f(x), provided te limit exists Te derivative function

More information

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

2.23 Gambling Rehabilitation Services. Introduction

2.23 Gambling Rehabilitation Services. Introduction 2.23 Gambling Reabilitation Services Introduction Figure 1 Since 1995 provincial revenues from gambling activities ave increased over 56% from $69.2 million in 1995 to $108 million in 2004. Te majority

More information