A Finite Element Primer

Size: px
Start display at page:

Download "A Finite Element Primer"

Transcription

1 A Finite Element Primer David J. Silvester Scool of Matematics, University of Mancester Version.3 updated 4 October Contents A Model Diffusion Problem x. Domain x. Continuous Function x.3 Normed Vector Space x.4 Square Integrable Function x.5 Inner Product Space x.6 Caucy Scwarz Inequality x.7 Sobolev Space x.8 Weak Derivative Galerkin Approximation x.9 Caucy Sequence x. Complete Space Finite Element Galerkin Approximation Tis is a summary of finite element teory for a diffusion problem in one dimension. It provides te matematical foundation for Capter of our reference book Finite Elements and Fast Iterative Solvers wit Applications in Incompressible Fluid Dynamics, see ttp:// i

2 A Model Diffusion Problem. A Model Diffusion Problem Te problem we consider erein is a two point boundary value problem. A formal statement is: given a real function f C (,) (see Definition x. below), we seek a function u C (,) C [,] (see below) satisfying u (x) = f(x) for < x < u() = ; u() =. Te term u = d u dx represents diffusion, and f is called te source term. A sufficiently smoot function u satisfying (D) is called a strong (or, in te case of continuous function f, a classical ) solution. Problem. (f = ) Tis is a model for te temperature in a wire wit te ends kept in ice. Tere is a current flowing in te wire wic generates eat. Solving (D) gives te parabolic ump u(x) = (x x ). } (D). Problem. Problem. temperature.5..5 deflection..5.5 x.5 x Some basic definitions will need to be added if our statement of (D) is to make sense. Definition x. (Domain) A domain is a bounded open set; for example, Ω = (,), wic identifes were a differential equation is defined. Te closure of te set, denoted Ω, includes all te points on te boundary of te domain; for example, Ω = [,].

3 A Model Diffusion Problem Definition x. (Continuous function) A real function f is mapping wic assigns a unique real number to every point in a domain: f : Ω R. C (Ω) is te set of all continuous functions defined on Ω. C k (Ω) is te set of all continuous functions wose kt derivatives are also continuous over Ω. C (Ω) is te set of all functions u C (Ω) suc tat u can be extended to a continuous function on Ω. Te standard way of categorizing spaces of functions is to use te notion of a norm. Tis is made explicit in te following definition. Definition x.3 (Normed vector space) A normed vector space V, as (or more formally is equipped wit ) a mapping : V R wic satisfies four axioms: u u V; (were means for all ) u = u = ; (were means if and only if ) 3 αu = α u, α R and u V; 4 u+v u + v u,v V. Note tat, if te second axiom is relaxed to te weaker condition u = u = ten V is only equipped wit a semi norm. A normed vector space tat is complete (see Definition x. below) is called a Banac Space. Two examples of normed vector spaces are given below. Example x.3. Suppose tat V = R, tat is, all vectors u = Valid norms are [ ux u y ]. u = u x + u y ; l norm u = (u x +u y) / ; l norm u = max{ u x, u y }. l norm Example x.3. Suppose tat V = C (Ω). A valid norm is u,ω = max u(x). L norm. x Ω Returning to (D), te source function f(x) may well be roug, f C (Ω). An example is given below.

4 A Model Diffusion Problem 3 Problem. (f(x) = H(x /); wereh(x)iste unitstep function wic switces from to at te origin) f(x) = x = x = f(x) = Tisisamodelforte deflectionofasimplysupportedelasticbeamsubject to a discontinuous load. Solving te differential equation over te two intervals and imposing continuity of te solution and te first derivative at te interface point x = / gives te generalized solution sown in te figure on page : { x u(x) = x x < x x. We will see later tat an appropriate place to look for u is inside te space of square integrable functions. Definition x.4 (Square integrable function) L (Ω) is te vector space of square integrable functions defined on Ω : u L (Ω) if and only if u <. Functions tat are not continuous in [,] may still be square integrable. We give two examples below. Example x.4. Consider f = x /4. f dx = Ω x / dx = ence f < so tat f L (Ω). { x < Example x.4. Consider f = x. f dx = = / / f dx+ dx+ / / f dx dx /

5 A Model Diffusion Problem 4 ence f < so tat f L (Ω). L (Ω) is a Banac space. Example x.3.3 Suppose tat V = L (Ω) wit Ω = (,). A valid norm is ( / u Ω = u dx). L norm L (Ω) is pretty special it is also equipped wit an inner product. Definition x.5 (Inner product space) An inner product space V, as a mapping (, ) : V V R wic satisfies four axioms: ➊ (u,w) = (w,u) u,w V; ➋ (u,u) u V; ➌ (u,u) = u = ; ➍ (αu+βv,w) = α(u,w)+β(v,w) α,β R; u,v,w V. Example x.5. Suppose tat V = R. A valid inner product is given by (u,w) = u x w x +u y w y = u w Example x.5. Suppose tat V = L (Ω), wit Ω = (,). A valid inner product is given by (u,w) = uw. A complete inner product space like L (Ω) is called a Hilbert Space. Note tat an inner product space is also a normed space. Tere is a natural (or energy ) norm u = (u,u). Inner products and norms are related by te Caucy Scwarz inequality. Definition x.6 (Caucy Scwarz inequality) (u,v) u v u,v V. (C S)

6 A Model Diffusion Problem 5 Example x.6. Suppose tat V = R. We ave te discrete version of C S: u w u w (u x +u y) / (w x +w y) /. Example x.6. Suppose tat V = L (Ω), wit Ω = (,). We ave uw ( ) /( ) / uw u w. Returning to Problem., we now address te question of were (in wic function space) do we look for te generalized solution u wen te function f is square integrable but not continuous? Te answer to tis is in a Sobolev space. Definition x.7 (Sobolev space) For a positive index k, te Sobolev space H k (,) is te set of functions v : (,) R suc tat v and all (weak-) derivatives up to and including k are square integrable: u H k (,) u <, (u ) <,..., (u (k) ) <. Note tat H k (,) defines a Hilbert space wit inner product and norm (u,w) k = uw+ ( u k = u + u w + (u ) u w (u (k) ) ) /. u (k) w (k) Returning to Problem., te appropriate solution space turns out to be } H (,) = {u L (,), u L (,); u() =, u() =. u H (,) essential b.c. s Tis is a big surprise: Tere are no second derivatives in te definition of H! First derivatives need not be continuous!

7 A Model Diffusion Problem 6 To elp understand were H (,) comes from, it is useful to reformulate (D) as a minimization problem. Specifically, given f L (,), we look for a minimizing function u H (,) satisfying F(u) F(v), v H (,), (M) were F : H (,) R is te so-called energy functional F(v) = (v ) fv, and H (,) is te associated minimizing set. Note tat bot rigt and side terms are finite, ( ) v H (,) ( ) fv ( (v ) < )/( )/ f v f L (Ω) v H (,) using C S fv <. Note also tat te definition of (M) and te construction ( ) suggests tat even rouger load data f may be allowable. Problem.3 (f(x) = δ(x /); were δ(x) is te Dirac delta function wic is zero at all points apart from te origin) x = / Tis gives a model for te deflection of a simply supported elastic beam subject to a point load. Te solution is called a fundamental solution or a Green s function. In tis case, since v H (,) v C (,), we ave tat fv = v(/) <, so tat (M) is well defined. (Note tat tis statement is only true for domains in R in iger dimensions te Dirac delta function is not admissible as load data.)

8 A Model Diffusion Problem 7 Returning to (M), we can compute u by solving te following variational formulation : given f L (,) find u H(,) suc tat u v = fv v H (,). (V) A solution to (V) (or, equivalently a solution to (M)) is called a weak solution. Te relationsip between (D), (M) and (V) is explored in te following tree teorems. Teorem. ((D) (V)) If u solves (D) ten it solves (V). Proof. Let u satisfy (D). Since continuous functions are square integrable ten u L (,) and u L (,). Furtermore since u() = = u() from te statement of (D), we ave tat u H(,). To sow (V), let v H (,), multiply (D) by v and integrate over Ω: Using integrating by parts gives were u v = u v = fv. u v [u v], [u (x)v(x)] = u ()v() u ()v(), and since v H (,) we ave v() = v() = so tat te boundary term is zero. Tus we ave tat u satisfies as required. u v = fv v H (,) Te above proof sows us ow to construct a weak formulation from a classical formulation. We now use te properties of an inner product in Definition x.5 to sow tat (V) as a unique solution. Teorem. A solution to (V) is unique. Proof. Let V = H(,) and assume tat tere are two weak solutions u (x) V, u (x) V suc tat (u,v ) = (f,v) v V, (a,b) = (u,v ) = (f,v) v V. ab;

9 A Model Diffusion Problem 8 Subtracting and ten using ➍ gives We now define w = u u, so tat (u,v ) (u,v ) = v V, (u u,v ) = v V. (w,v )= v V. ( ) Our aim is to sow tat w = in (,) (so tat u = u.) To do tis we note tat w V (by te definition of a vector space) and set v = w in ( ). Using ➌ ten gives (w,w ) = w =. ( ) From wic we migt deduce tat w is constant. Finally, if we use te fact tat functions in V are continuous over [,], and are zero at te end points, we can see tat w = as required. Te ole in te above argument is tat two square integrable functions wic are identical in [,] except at a finite set of points are equivalent to eac oter. (Tey cannot be distinguised from eac oter in te sense of taking teir L norm.) Tus, a more precise statement of ( ) is tat w = almost everwere. Tus a more rigorous way of establising uniqueness is to use te famous Poincaré Friedric inequality. Lemma.3 (Poincaré Friedric) If w H (,) ten Proof. See below. w (w ). (P F) Tus, starting from ( ) and using P F gives w (w ) = and we deduce tat w = almost everywere in (,), so tat tere is a unique solution to (V) in te L sense. Proof. (of P F) Suppose w H (,), ten w(x) = w()+ x w (ξ)dξ.

10 A Model Diffusion Problem 9 Tus, since w() = we ave x w (x) = w dξ ( x )( x dξ ( )( dξ }{{ } = ) (w ) dξ ) (w ) dξ using C S because x. Hence w (x) (w ) dξ, and integrating over (,) gives { } { } w (w ) dξ dx = (w ) dx } {{ } R + = as required. Teorem.4 ((V) (M)) If u solves (V) ten u solves (M) and vice versa. Proof. (I) (V) (M) Let u H (,) be te solution of (V), tat is, (u,v ) = (f,v) v H (,). Suppose v H (,), and define w = v u H (,), ten using te symmetry ➊ and linearity ➍ of te inner product gives F(v) = F(u+w) = ((u+w),(u+w) ) (f,u+w) = (u,u ) (f,u)+ (u,w ) + (w,u ) (f,w)+ (w,w ) (u,w ) = (u,u ) (f,u)+ (w,w )+(u,w ) (f,w) = = F(u)+ (w,w ). Finally, using ➋, we ave tat F(v) F(u) as required.

11 A Model Diffusion Problem (II) (V) (M). Let u H (,) be te solution of (M), tat is F(u) F(v) v H (,). Tus, given a function v H (,) and ε R, u + εv H (,), so tat F(u) F(u+εv). We now define g(ε) := F(u+εv). Tis function is is minimised wen ε =, so tat we ave tat dg =. Now, ε= dε g(ε) = ((u+εv),(u+εv) ) (f,u+εv) = ε (v,v )+ε(u,v ) ε(f,v)+ (u,u ) (f,u) dg and so, = ε(v,v )+(u,v ) (f,v). dε Finally, setting dg = we see tat u solves (V). ε= dε In summary, we ave tat (D) (V) (M). Te converse implication (D) (V) is not true unless u H (,) is smoot enoug to ensure tat u C (,). In tis special case, we ave tat (D) (V). Returning to (M) and te space H (,), a very important property of L (Ω) is te concept of a weak derivative. Definition x.8 (Weak derivative) u L (Ω) possesses a weak derivative u L (Ω) satisfying (φ, u) = (φ,u) φ C (Ω), (W D) were C (Ω) is te space of infinitely differentiable functions wic are zero outside Ω. Example x.8. Consider te function u = x wit Ω = (,). x = x =

12 Galerkin Approximation Tis function is not differentiable in te classical sense. However, starting from te rigt and side of W D, and integrating by parts gives ( ) dφ dx,u = = = = x dφ dx ( x) dφ dx x dφ dx d dx ( x)φ+ d dx (x)φ [ ] [ ] ( x)φ (x)φ φ φ() φ( ) { } d dx ( x) + φ() φ() Tus te weak derivative is a step function, {, < x < u =, < x <. Note tat te value of u is not defined at te origin.. Galerkin Approximation φ { d dx (x) } = (φ, u). We now introduce a finite dimensional subspace V k H (,). Tis is associated wit a set of basis functions V k = span{φ (x),φ (x),...,φ k (x)} so tat every element of V k, say u k, can be uniquely written as u k (x) = k α j φ j (x), α j R. j= To compute te Galerkin approximation, we pose te variational problem (V) over V k. Tat is, we seek u k V k suc tat (u k,v k ) = (f,v k) v k V k. (V )

13 Galerkin Approximation Equivalently, since {φ i } k i= are a basis set, we ave tat ( (u k,φ i) = (f,φ i ) i =,,...,k k α j φ j ),φ i = (f,φ i ) j= k j= ( α j φ j,φ ) i = (f,φ i ). Tis can be written in matrix form as Ax = f (V ) wit A ij = ( φ j i),φ, xj = α j, and f i = (f,φ i ), i,j =,...,k. (V ) is called te Galerkin system, A is called te stiffness matrix, f is te load vector and u k = k j= α jφ j is te Galerkin solution. Teorem. Te stiffness matrix is symmetric and positive definite. Proof. Symmetry follows from ➊. To establis positive definiteness we consider te quadratic form and use ➍: x T Ax = k k j= i= α ja ji α i = k k j= i= α ( j φ j,φ i ( k ) = j= α jφ j, k i= α iφ i = (u k,u k ). Tus from ➋ we see tat A is at least semi-definite. Definiteness follows from te fact tat x T Ax = if and only if u k =. But since u k H (,) ten u k = implies tat u k =. Finally, since {φ i } k i= are a basis set, we ave tat u k = implies tat x =. Teorem. implies tat A is nonsingular. Tis means tat te solution x (and ence u k ) exists and is unique. An alternative approac, te so-called Rayleig Ritz metod, is obtained by posing te minimization problem (M) over te finite dimensional subspace V k. Tat is, we seek u k V k suc tat ) αi F(u k ) F(v k ) v k V k. (M ) Doing tis leads to te matrix system (V ) so tat te Ritz solution and te Galerkin solution are one and te same. Te beauty of Galerkin s metod is te best approximation property.

14 Galerkin Approximation 3 Teorem. (Best approximation) If u is te solution of (V) and u k is te Galerkin solution, ten u u k u v k v k V k. (B A) Proof. Te functions u k and u satisfy te following u k V k ; (u k,v k) = (f,v k ) v k V k But since V k V we ave tat u V; (u,v ) = (f,v) v V. (u,v k ) = (f,v k) v k V k. Subtracting equations and using ➍ gives (u,v k) (u k,v k) = v k V k (u u k,v k ) = v k V k (G O) Tis means tat te error u u k is ortogonal to te subspace V k a property known as Galerkin ortogonality. To establis te best approximation property we start wit te left and side of B A and use Galerkin ortogonality as follows: u u k = (u u k,u u k ( ) ) = (u u k,u ) u u k,u k u k V k } {{ } { = }} G O { = (u u k,u ) (u u k,v k) v k V k = (u u k,u v k) u u k u v k. using C S Hence, dividing by u u k > as required. u u k u v k v k V k, An important observation ere is tat we ave a natural norm to measure errors wic is inerited from te minimimization problem (M). If u u k = ten B A olds trivially.

15 Galerkin Approximation 4 Example x.3.4 Suppose V = H (,). A valid norm is v E = (v,v ) / = v. Tis is called te energy norm. A tecnical issue tat arises ere is tat te best approximation property does not automatically imply tat te Galerkin metod converges in te sense tat u u k E as k. For convergence, we really need to introduce te concept of a complete space tat was postponed earlier. Definition x.9 (Caucy sequence) A sequence (v (k) ) V is called a Caucy sequence in a normed space V if for any ε >, tere exists a positive integer k (ε) suc tat v (l) v (m) V < ε l,m k. A Caucy sequence is convergent, so te only issue is weter te limit of te sequence is in te correct space. Tis motivates te following definition. Definition x. (Complete space) AnormedspaceV iscompleteifitcontainstelimitsofallcaucysequences in V. Tat is, if (v (k) ) is a Caucy sequence in V, ten tere exists ξ V suc tat lim k v(k) ξ V =. We write tis informally as lim k v (k) = ξ. Example x.. Te space H(,) is complete wit respect to te energy norm E. Te upsot is tat te Galerkin approximation is guaranteed to converge to te weak solution in te limit k. We now introduce a simple-minded Galerkin approximation based on global polynomials. Tat is, we coose V k = span {,x,x,...,x k }. To ensure tat V k V, te function u k = j α jx j must satisfy two conditions: (I) u k H (,); (II) u k () = = u k ().

16 Galerkin Approximation 5 Te first condition is no problem, u k C (,)! To satisfy te second condition we need to modify te basis set to te following, V k = span { x(x ),x (x ),x 3 (x )...,x k (x ) }. Problem. (f = ) Consider V = span{ x(x ),x } (x ) φ Ten constructing te matrix system (V ), we ave tat Tis gives ( 3 A = A = A = 6 f = f = 6 5 )( α α (φ ) = φ φ = (φ ) = φ = φ = ) So te Galerkin solution is = φ ( d dx (x x) ) = 3 d dx (x x) d dx (x3 x ) = 6 = A ( d dx (x3 x ) ) = 5 x x = 6 x 3 x =. ( 6 ) ( α α u (x) = φ +φ = (x x ) = u(x). ) = ( Te fact tat te Galerkin approximation agrees wit te exact solution is to be expected given te best approximation property and noting tat u V. Problem. (f(x) = H(x /)) Consider V as above. In tis case, ). f = f = φ = φ = x 3 x = 5 9.

17 Finite Element Galerkin Approximation 6 Tis gives te Galerkin system ( )( α α ) = ( 5 9 Note tat te Galerkin solution is not exact in tis instance. Te big problem wit global polynomial approximation is tat te Galerkin matrix becomes increasingly ill conditioned as k is increased. Computationally, it beaves like a Hilbert matrix and so reliable computation for k > is not possible. For tis reason, piecewise polynomial basis functions are used in practice instead of global polynomial functions. 3. Finite Element Galerkin Approximation A piecewise polynomial approximation space can be constructed in four steps. Step(i) Subdivision of Ω into elements. For Ω = [,] te elements are intervals as illustrated below. n x = x = Step (ii) Piecewise approximation of u using a low-order polynomial (e.g. linear): u u e u n x x In general, a linear function u e (x) is defined by its values at two distinct points x x l e (x) = u e (x) = (x x ) (x x ) l e (x) ) u e (x )+ (x x ) (x x ) l e (x). u e (x ). l i (x) are called nodal basis functions and satisfy te interpolation conditions linear over e if x = x if x = x ; l e (x) = linear over e if x = x if x = x.

18 Finite Element Galerkin Approximation 7 Step (iii) Satisfaction of te smootness requirement (I). Tis is done by carefully positioning te nodes, so tat x and x are at te end points of te interval. u k (x ) u k (x ) u k (x 3 ) u k (x n ) u k (x ) u k (x n ) x = x = 3 n x x x x 3 x n x n Concatenatingte element functions u e (x) givesaglobalfunction u k (x) u k (x) = n u e (x). e = Tusu k (x) is defined byk = n internalvalues, andte twoboundary values u k (x ) = u k () and u k (x n ) = u k (). We can ten define N i (x), te so called global basis function, so tat N i (x) = if x = x i if x = x j (j i) linear in every element e, N i (x) x i 3 x i x i x i x i+ x i+ and write u k (x) = α N (x)+α N (x)+...+α n N n (x). Note tat u k (x i ) = α i, so tat te unknowns are te function values at te nodes.

19 Finite Element Galerkin Approximation 8 Step (iv) Satisfaction of te essential boundary condition requirement (II). Tis is easy we simply remove te basis functions N (x) and N n (x) from te basis set. Te modified Galerkin approximation is u k (x) = α N (x)+...+α n N n (x), and is associated wit te approximation space Problem 3. (f(x) = ) Consider five equal lengt elements V n = span{n,...,n n } x = x = 5 x = 5 x 3 = 3 5 x 4 = 4 x 5 = 5 so tat V 6 = span{n i } 5 i=. For computational convenience te Galerkin system coefficients A ij = N j N i, b i = may be computed element by element. Tat is, A ij = 5 k= xk x k N j N i xk dls dl t x k dx dx, b i = 5 k= N i, xk x k N i xk x k l t were s and t are local indices referring to te associated element basis functions illustrated below. l (x) N k (x) x k k x k x k+,

20 Finite Element Galerkin Approximation 9 N k (x) l (x) x k x k k x k In particular, in element k tere are two nodal basis functions so tat l (x) = (x x k ) (x k x k ), l (x) = (x x k) (x k x k ), dl dx =, dl dx =, wit = x k x k = /5. Tis generates a element contribution matrix xk xk (l ) l l A k x k x k = xk xk l l (l = ) x k x k and a ( ) element contribution vector b k = xk x k l xk x k l =.

21 Finite Element Galerkin Approximation Summing over te element contributions gives te stiffness matrix and te load vector, A = + + A A... + A 5 b =

22 Finite Element Galerkin Approximation Tus, te assembled Galerkin system is A x b α α α α 3 α 4 α 5 =. Note tat tis system is singular (and inconsistent!). All te columns sum to zero, so tat A =. Tis problem arises because we ave not yet imposed te essentialboundary conditions. To do tis we simply need to removen (x) and N 5 (x) from te basis set, tat is, delete te first and last row and column from te system. Doing tis gives te nonsingular reduced system α α =. α 3 α 4 A x b Setting = /5, and solving gives α = α 4 =.8; α = α 3 =.; so te Galerkin finite element solution is u 4(x) =.8N (x)+.n (x)+.n 3 (x)+.8n 4 (x). It is illustrated below. Note tat u 4(x i ) = u(x i ) so te finite element solution is exact at te nodes! It is not exact at any point in between te nodes owever.

23 Finite Element Galerkin Approximation 8 x x x 3 x 4 Note also tat te generic equation x i x i x i+ = corresponds to a centered finite difference approximation to u =. To complete te discussion we would like to sow tat te finite element solution converges to te weak solution in te limit. Teorem 3. (Convergence in te energy norm) If u is te solution of (V) and u k is te finite element solution based on linear approximation ten u u k E f were is te lengt of te longest element in te subdivision (wic does not ave to be uniform.) Proof. We now formally introduce te linear interpolant, u V k of te exact solution, so tat u(x i ) = u (x i ) i =,,,...,n. Note tat we cannot assume tat u k = u in general. Introducing e(x) = u(x) u (x), we see tat e V k and tat e(x i ) =, i =,,,...,n.

24 Finite Element Galerkin Approximation 3 We can now bound te element interpolation error using standard tools from approximation teory xi xi (e ) (x i x i ) (e ) x i x i = (x i x i ) xi xi x i (u ) x i (u ) were = max i x i x i. Summingoverteintervalstengivesteestimate Finally, using B A (e ) (u ). (u u k ) (u u ) u = f <. Tus lim u k = u in te energy norm. To get an error estimate in L we use a very clever duality argument. Teorem 3. (Aubin Nitsce) If u is te solution of (V) and u k is te finite element solution based on linear approximation ten u u k f. Proof. Let w be te solution of te dual problem Ten we ave w = u u k x (,); w() = = w(). u u k = (u u k,u u k ) = (u u k, w ) = (u u k,w ) (since w() = w() = ) = (u u k,w ) (u u k,(w ) ), w V k, G O were w is te interpolant of w in V k. Hence u u k = (u u k,(w w ) ) u u k (w w ) C S w = u u k.

25 Finite Element Galerkin Approximation 4 Hence, assuming tat u u k >, we ave tat as required. u u k u u k f, A more complete discussion of tese issues can be found in Capters and 4 of te following reference book. Endre Süli & David Mayers, An Introduction to Numerical Analysis, Cambridge University Press, 3.

Differentiation in higher dimensions

Differentiation in higher dimensions Capter 2 Differentiation in iger dimensions 2.1 Te Total Derivative Recall tat if f : R R is a 1-variable function, and a R, we say tat f is differentiable at x = a if and only if te ratio f(a+) f(a) tends

More information

Poisson Equation in Sobolev Spaces

Poisson Equation in Sobolev Spaces Poisson Equation in Sobolev Spaces OcMountain Dayligt Time. 6, 011 Today we discuss te Poisson equation in Sobolev spaces. It s existence, uniqueness, and regularity. Weak Solution. u = f in, u = g on

More information

Consider a function f we ll specify which assumptions we need to make about it in a minute. Let us reformulate the integral. 1 f(x) dx.

Consider a function f we ll specify which assumptions we need to make about it in a minute. Let us reformulate the integral. 1 f(x) dx. Capter 2 Integrals as sums and derivatives as differences We now switc to te simplest metods for integrating or differentiating a function from its function samples. A careful study of Taylor expansions

More information

MATH745 Fall MATH745 Fall

MATH745 Fall MATH745 Fall MATH745 Fall 5 MATH745 Fall 5 INTRODUCTION WELCOME TO MATH 745 TOPICS IN NUMERICAL ANALYSIS Instructor: Dr Bartosz Protas Department of Matematics & Statistics Email: bprotas@mcmasterca Office HH 36, Ext

More information

Analytic Functions. Differentiable Functions of a Complex Variable

Analytic Functions. Differentiable Functions of a Complex Variable Analytic Functions Differentiable Functions of a Complex Variable In tis capter, we sall generalize te ideas for polynomials power series of a complex variable we developed in te previous capter to general

More information

Lecture Notes for the Course Numerical Methods for Partial Differential Equations

Lecture Notes for the Course Numerical Methods for Partial Differential Equations Lecture Notes for te Course Numerical Metods for Partial Differential Equations Walter Zulener Institute for Computational Matematics Joannes Kepler University Linz Winter Semester 25/6 Contents 1 Elliptic

More information

Function Composition and Chain Rules

Function Composition and Chain Rules Function Composition and s James K. Peterson Department of Biological Sciences and Department of Matematical Sciences Clemson University Marc 8, 2017 Outline 1 Function Composition and Continuity 2 Function

More information

5 Ordinary Differential Equations: Finite Difference Methods for Boundary Problems

5 Ordinary Differential Equations: Finite Difference Methods for Boundary Problems 5 Ordinary Differential Equations: Finite Difference Metods for Boundary Problems Read sections 10.1, 10.2, 10.4 Review questions 10.1 10.4, 10.8 10.9, 10.13 5.1 Introduction In te previous capters we

More information

Order of Accuracy. ũ h u Ch p, (1)

Order of Accuracy. ũ h u Ch p, (1) Order of Accuracy 1 Terminology We consider a numerical approximation of an exact value u. Te approximation depends on a small parameter, wic can be for instance te grid size or time step in a numerical

More information

Gradient Descent etc.

Gradient Descent etc. 1 Gradient Descent etc EE 13: Networked estimation and control Prof Kan) I DERIVATIVE Consider f : R R x fx) Te derivative is defined as d fx) = lim dx fx + ) fx) Te cain rule states tat if d d f gx) )

More information

Dedicated to the 70th birthday of Professor Lin Qun

Dedicated to the 70th birthday of Professor Lin Qun Journal of Computational Matematics, Vol.4, No.3, 6, 4 44. ACCELERATION METHODS OF NONLINEAR ITERATION FOR NONLINEAR PARABOLIC EQUATIONS Guang-wei Yuan Xu-deng Hang Laboratory of Computational Pysics,

More information

1 Calculus. 1.1 Gradients and the Derivative. Q f(x+h) f(x)

1 Calculus. 1.1 Gradients and the Derivative. Q f(x+h) f(x) Calculus. Gradients and te Derivative Q f(x+) δy P T δx R f(x) 0 x x+ Let P (x, f(x)) and Q(x+, f(x+)) denote two points on te curve of te function y = f(x) and let R denote te point of intersection of

More information

Convexity and Smoothness

Convexity and Smoothness Capter 4 Convexity and Smootness 4.1 Strict Convexity, Smootness, and Gateaux Differentiablity Definition 4.1.1. Let X be a Banac space wit a norm denoted by. A map f : X \{0} X \{0}, f f x is called a

More information

Polynomial Interpolation

Polynomial Interpolation Capter 4 Polynomial Interpolation In tis capter, we consider te important problem of approximatinga function fx, wose values at a set of distinct points x, x, x,, x n are known, by a polynomial P x suc

More information

Chapter 5 FINITE DIFFERENCE METHOD (FDM)

Chapter 5 FINITE DIFFERENCE METHOD (FDM) MEE7 Computer Modeling Tecniques in Engineering Capter 5 FINITE DIFFERENCE METHOD (FDM) 5. Introduction to FDM Te finite difference tecniques are based upon approximations wic permit replacing differential

More information

LIMITS AND DERIVATIVES CONDITIONS FOR THE EXISTENCE OF A LIMIT

LIMITS AND DERIVATIVES CONDITIONS FOR THE EXISTENCE OF A LIMIT LIMITS AND DERIVATIVES Te limit of a function is defined as te value of y tat te curve approaces, as x approaces a particular value. Te limit of f (x) as x approaces a is written as f (x) approaces, as

More information

Finite Difference Method

Finite Difference Method Capter 8 Finite Difference Metod 81 2nd order linear pde in two variables General 2nd order linear pde in two variables is given in te following form: L[u] = Au xx +2Bu xy +Cu yy +Du x +Eu y +Fu = G According

More information

A SHORT INTRODUCTION TO BANACH LATTICES AND

A SHORT INTRODUCTION TO BANACH LATTICES AND CHAPTER A SHORT INTRODUCTION TO BANACH LATTICES AND POSITIVE OPERATORS In tis capter we give a brief introduction to Banac lattices and positive operators. Most results of tis capter can be found, e.g.,

More information

How to Find the Derivative of a Function: Calculus 1

How to Find the Derivative of a Function: Calculus 1 Introduction How to Find te Derivative of a Function: Calculus 1 Calculus is not an easy matematics course Te fact tat you ave enrolled in suc a difficult subject indicates tat you are interested in te

More information

1 The concept of limits (p.217 p.229, p.242 p.249, p.255 p.256) 1.1 Limits Consider the function determined by the formula 3. x since at this point

1 The concept of limits (p.217 p.229, p.242 p.249, p.255 p.256) 1.1 Limits Consider the function determined by the formula 3. x since at this point MA00 Capter 6 Calculus and Basic Linear Algebra I Limits, Continuity and Differentiability Te concept of its (p.7 p.9, p.4 p.49, p.55 p.56). Limits Consider te function determined by te formula f Note

More information

Math 161 (33) - Final exam

Math 161 (33) - Final exam Name: Id #: Mat 161 (33) - Final exam Fall Quarter 2015 Wednesday December 9, 2015-10:30am to 12:30am Instructions: Prob. Points Score possible 1 25 2 25 3 25 4 25 TOTAL 75 (BEST 3) Read eac problem carefully.

More information

Convexity and Smoothness

Convexity and Smoothness Capter 4 Convexity and Smootness 4. Strict Convexity, Smootness, and Gateaux Di erentiablity Definition 4... Let X be a Banac space wit a norm denoted by k k. A map f : X \{0}!X \{0}, f 7! f x is called

More information

Mass Lumping for Constant Density Acoustics

Mass Lumping for Constant Density Acoustics Lumping 1 Mass Lumping for Constant Density Acoustics William W. Symes ABSTRACT Mass lumping provides an avenue for efficient time-stepping of time-dependent problems wit conforming finite element spatial

More information

Polynomial Interpolation

Polynomial Interpolation Capter 4 Polynomial Interpolation In tis capter, we consider te important problem of approximating a function f(x, wose values at a set of distinct points x, x, x 2,,x n are known, by a polynomial P (x

More information

NUMERICAL DIFFERENTIATION

NUMERICAL DIFFERENTIATION NUMERICAL IFFERENTIATION FIRST ERIVATIVES Te simplest difference formulas are based on using a straigt line to interpolate te given data; tey use two data pints to estimate te derivative. We assume tat

More information

Chapter 10. Function approximation Function approximation. The Lebesgue space L 2 (I)

Chapter 10. Function approximation Function approximation. The Lebesgue space L 2 (I) Capter 1 Function approximation We ave studied metods for computing solutions to algebraic equations in te form of real numbers or finite dimensional vectors of real numbers. In contrast, solutions to

More information

IEOR 165 Lecture 10 Distribution Estimation

IEOR 165 Lecture 10 Distribution Estimation IEOR 165 Lecture 10 Distribution Estimation 1 Motivating Problem Consider a situation were we ave iid data x i from some unknown distribution. One problem of interest is estimating te distribution tat

More information

arxiv: v1 [math.na] 28 Apr 2017

arxiv: v1 [math.na] 28 Apr 2017 THE SCOTT-VOGELIUS FINITE ELEMENTS REVISITED JOHNNY GUZMÁN AND L RIDGWAY SCOTT arxiv:170500020v1 [matna] 28 Apr 2017 Abstract We prove tat te Scott-Vogelius finite elements are inf-sup stable on sape-regular

More information

arxiv: v1 [math.na] 12 Mar 2018

arxiv: v1 [math.na] 12 Mar 2018 ON PRESSURE ESTIMATES FOR THE NAVIER-STOKES EQUATIONS J A FIORDILINO arxiv:180304366v1 [matna 12 Mar 2018 Abstract Tis paper presents a simple, general tecnique to prove finite element metod (FEM) pressure

More information

Numerical Experiments Using MATLAB: Superconvergence of Nonconforming Finite Element Approximation for Second-Order Elliptic Problems

Numerical Experiments Using MATLAB: Superconvergence of Nonconforming Finite Element Approximation for Second-Order Elliptic Problems Applied Matematics, 06, 7, 74-8 ttp://wwwscirporg/journal/am ISSN Online: 5-7393 ISSN Print: 5-7385 Numerical Experiments Using MATLAB: Superconvergence of Nonconforming Finite Element Approximation for

More information

Combining functions: algebraic methods

Combining functions: algebraic methods Combining functions: algebraic metods Functions can be added, subtracted, multiplied, divided, and raised to a power, just like numbers or algebra expressions. If f(x) = x 2 and g(x) = x + 2, clearly f(x)

More information

Click here to see an animation of the derivative

Click here to see an animation of the derivative Differentiation Massoud Malek Derivative Te concept of derivative is at te core of Calculus; It is a very powerful tool for understanding te beavior of matematical functions. It allows us to optimize functions,

More information

NUMERICAL DIFFERENTIATION. James T. Smith San Francisco State University. In calculus classes, you compute derivatives algebraically: for example,

NUMERICAL DIFFERENTIATION. James T. Smith San Francisco State University. In calculus classes, you compute derivatives algebraically: for example, NUMERICAL DIFFERENTIATION James T Smit San Francisco State University In calculus classes, you compute derivatives algebraically: for example, f( x) = x + x f ( x) = x x Tis tecnique requires your knowing

More information

Strongly continuous semigroups

Strongly continuous semigroups Capter 2 Strongly continuous semigroups Te main application of te teory developed in tis capter is related to PDE systems. Tese systems can provide te strong continuity properties only. 2.1 Closed operators

More information

A h u h = f h. 4.1 The CoarseGrid SystemandtheResidual Equation

A h u h = f h. 4.1 The CoarseGrid SystemandtheResidual Equation Capter Grid Transfer Remark. Contents of tis capter. Consider a grid wit grid size and te corresponding linear system of equations A u = f. Te summary given in Section 3. leads to te idea tat tere migt

More information

University Mathematics 2

University Mathematics 2 University Matematics 2 1 Differentiability In tis section, we discuss te differentiability of functions. Definition 1.1 Differentiable function). Let f) be a function. We say tat f is differentiable at

More information

1. Introduction. We consider the model problem: seeking an unknown function u satisfying

1. Introduction. We consider the model problem: seeking an unknown function u satisfying A DISCONTINUOUS LEAST-SQUARES FINITE ELEMENT METHOD FOR SECOND ORDER ELLIPTIC EQUATIONS XIU YE AND SHANGYOU ZHANG Abstract In tis paper, a discontinuous least-squares (DLS) finite element metod is introduced

More information

Analysis of A Continuous Finite Element Method for H(curl, div)-elliptic Interface Problem

Analysis of A Continuous Finite Element Method for H(curl, div)-elliptic Interface Problem Analysis of A Continuous inite Element Metod for Hcurl, div)-elliptic Interface Problem Huoyuan Duan, Ping Lin, and Roger C. E. Tan Abstract In tis paper, we develop a continuous finite element metod for

More information

3 Parabolic Differential Equations

3 Parabolic Differential Equations 3 Parabolic Differential Equations 3.1 Classical solutions We consider existence and uniqueness results for initial-boundary value problems for te linear eat equation in Q := Ω (, T ), were Ω is a bounded

More information

Math 102 TEST CHAPTERS 3 & 4 Solutions & Comments Fall 2006

Math 102 TEST CHAPTERS 3 & 4 Solutions & Comments Fall 2006 Mat 102 TEST CHAPTERS 3 & 4 Solutions & Comments Fall 2006 f(x+) f(x) 10 1. For f(x) = x 2 + 2x 5, find ))))))))) and simplify completely. NOTE: **f(x+) is NOT f(x)+! f(x+) f(x) (x+) 2 + 2(x+) 5 ( x 2

More information

Symmetry Labeling of Molecular Energies

Symmetry Labeling of Molecular Energies Capter 7. Symmetry Labeling of Molecular Energies Notes: Most of te material presented in tis capter is taken from Bunker and Jensen 1998, Cap. 6, and Bunker and Jensen 2005, Cap. 7. 7.1 Hamiltonian Symmetry

More information

Continuity and Differentiability of the Trigonometric Functions

Continuity and Differentiability of the Trigonometric Functions [Te basis for te following work will be te definition of te trigonometric functions as ratios of te sides of a triangle inscribed in a circle; in particular, te sine of an angle will be defined to be te

More information

Generic maximum nullity of a graph

Generic maximum nullity of a graph Generic maximum nullity of a grap Leslie Hogben Bryan Sader Marc 5, 2008 Abstract For a grap G of order n, te maximum nullity of G is defined to be te largest possible nullity over all real symmetric n

More information

LECTURE 14 NUMERICAL INTEGRATION. Find

LECTURE 14 NUMERICAL INTEGRATION. Find LECTURE 14 NUMERCAL NTEGRATON Find b a fxdx or b a vx ux fx ydy dx Often integration is required. However te form of fx may be suc tat analytical integration would be very difficult or impossible. Use

More information

Numerical Solution to Parabolic PDE Using Implicit Finite Difference Approach

Numerical Solution to Parabolic PDE Using Implicit Finite Difference Approach Numerical Solution to arabolic DE Using Implicit Finite Difference Approac Jon Amoa-Mensa, Francis Oene Boateng, Kwame Bonsu Department of Matematics and Statistics, Sunyani Tecnical University, Sunyani,

More information

lecture 26: Richardson extrapolation

lecture 26: Richardson extrapolation 43 lecture 26: Ricardson extrapolation 35 Ricardson extrapolation, Romberg integration Trougout numerical analysis, one encounters procedures tat apply some simple approximation (eg, linear interpolation)

More information

1. Questions (a) through (e) refer to the graph of the function f given below. (A) 0 (B) 1 (C) 2 (D) 4 (E) does not exist

1. Questions (a) through (e) refer to the graph of the function f given below. (A) 0 (B) 1 (C) 2 (D) 4 (E) does not exist Mat 1120 Calculus Test 2. October 18, 2001 Your name Te multiple coice problems count 4 points eac. In te multiple coice section, circle te correct coice (or coices). You must sow your work on te oter

More information

A CLASS OF EVEN DEGREE SPLINES OBTAINED THROUGH A MINIMUM CONDITION

A CLASS OF EVEN DEGREE SPLINES OBTAINED THROUGH A MINIMUM CONDITION STUDIA UNIV. BABEŞ BOLYAI, MATHEMATICA, Volume XLVIII, Number 3, September 2003 A CLASS OF EVEN DEGREE SPLINES OBTAINED THROUGH A MINIMUM CONDITION GH. MICULA, E. SANTI, AND M. G. CIMORONI Dedicated to

More information

SECTION 3.2: DERIVATIVE FUNCTIONS and DIFFERENTIABILITY

SECTION 3.2: DERIVATIVE FUNCTIONS and DIFFERENTIABILITY (Section 3.2: Derivative Functions and Differentiability) 3.2.1 SECTION 3.2: DERIVATIVE FUNCTIONS and DIFFERENTIABILITY LEARNING OBJECTIVES Know, understand, and apply te Limit Definition of te Derivative

More information

232 Calculus and Structures

232 Calculus and Structures 3 Calculus and Structures CHAPTER 17 JUSTIFICATION OF THE AREA AND SLOPE METHODS FOR EVALUATING BEAMS Calculus and Structures 33 Copyrigt Capter 17 JUSTIFICATION OF THE AREA AND SLOPE METHODS 17.1 THE

More information

Variational Localizations of the Dual Weighted Residual Estimator

Variational Localizations of the Dual Weighted Residual Estimator Publised in Journal for Computational and Applied Matematics, pp. 192-208, 2015 Variational Localizations of te Dual Weigted Residual Estimator Tomas Ricter Tomas Wick Te dual weigted residual metod (DWR)

More information

HOMEWORK HELP 2 FOR MATH 151

HOMEWORK HELP 2 FOR MATH 151 HOMEWORK HELP 2 FOR MATH 151 Here we go; te second round of omework elp. If tere are oters you would like to see, let me know! 2.4, 43 and 44 At wat points are te functions f(x) and g(x) = xf(x)continuous,

More information

Function Composition and Chain Rules

Function Composition and Chain Rules Function Composition an Cain Rules James K. Peterson Department of Biological Sciences an Department of Matematical Sciences Clemson University November 2, 2018 Outline Function Composition an Continuity

More information

Numerical Differentiation

Numerical Differentiation Numerical Differentiation Finite Difference Formulas for te first derivative (Using Taylor Expansion tecnique) (section 8.3.) Suppose tat f() = g() is a function of te variable, and tat as 0 te function

More information

3.4 Worksheet: Proof of the Chain Rule NAME

3.4 Worksheet: Proof of the Chain Rule NAME Mat 1170 3.4 Workseet: Proof of te Cain Rule NAME Te Cain Rule So far we are able to differentiate all types of functions. For example: polynomials, rational, root, and trigonometric functions. We are

More information

SECTION 1.10: DIFFERENCE QUOTIENTS LEARNING OBJECTIVES

SECTION 1.10: DIFFERENCE QUOTIENTS LEARNING OBJECTIVES (Section.0: Difference Quotients).0. SECTION.0: DIFFERENCE QUOTIENTS LEARNING OBJECTIVES Define average rate of cange (and average velocity) algebraically and grapically. Be able to identify, construct,

More information

Superconvergence of energy-conserving discontinuous Galerkin methods for. linear hyperbolic equations. Abstract

Superconvergence of energy-conserving discontinuous Galerkin methods for. linear hyperbolic equations. Abstract Superconvergence of energy-conserving discontinuous Galerkin metods for linear yperbolic equations Yong Liu, Ci-Wang Su and Mengping Zang 3 Abstract In tis paper, we study superconvergence properties of

More information

LEAST-SQUARES FINITE ELEMENT APPROXIMATIONS TO SOLUTIONS OF INTERFACE PROBLEMS

LEAST-SQUARES FINITE ELEMENT APPROXIMATIONS TO SOLUTIONS OF INTERFACE PROBLEMS SIAM J. NUMER. ANAL. c 998 Society for Industrial Applied Matematics Vol. 35, No., pp. 393 405, February 998 00 LEAST-SQUARES FINITE ELEMENT APPROXIMATIONS TO SOLUTIONS OF INTERFACE PROBLEMS YANZHAO CAO

More information

7.1 Using Antiderivatives to find Area

7.1 Using Antiderivatives to find Area 7.1 Using Antiderivatives to find Area Introduction finding te area under te grap of a nonnegative, continuous function f In tis section a formula is obtained for finding te area of te region bounded between

More information

Sin, Cos and All That

Sin, Cos and All That Sin, Cos and All Tat James K. Peterson Department of Biological Sciences and Department of Matematical Sciences Clemson University Marc 9, 2017 Outline Sin, Cos and all tat! A New Power Rule Derivatives

More information

Volume 29, Issue 3. Existence of competitive equilibrium in economies with multi-member households

Volume 29, Issue 3. Existence of competitive equilibrium in economies with multi-member households Volume 29, Issue 3 Existence of competitive equilibrium in economies wit multi-member ouseolds Noriisa Sato Graduate Scool of Economics, Waseda University Abstract Tis paper focuses on te existence of

More information

A Demonstration of the Advantage of Asymptotic Preserving Schemes over Standard Finite Volume Schemes

A Demonstration of the Advantage of Asymptotic Preserving Schemes over Standard Finite Volume Schemes A Demonstration of te Advantage of Asymptotic Preserving Scemes over Standard Finite Volume Scemes Jocen Scütz Berict Nr. 366 Juni 213 Key words: conservation laws, asymptotic metods, finite volume metods,

More information

Digital Filter Structures

Digital Filter Structures Digital Filter Structures Te convolution sum description of an LTI discrete-time system can, in principle, be used to implement te system For an IIR finite-dimensional system tis approac is not practical

More information

2 Multi-Dimensional Variational Principles y s n u = α θ pu = β n Ω Figure 3..: Two-dimensional region wit and normal vector n x were

2 Multi-Dimensional Variational Principles y s n u = α θ pu = β n Ω Figure 3..: Two-dimensional region wit and normal vector n x were Capter 3 Multi-Dimensional Variational Principles 3. Galerkin's Metod and Extremal Principles Te construction of Galerkin formulations presented in Capters and 2 for one-dimensional problems readily extends

More information

1. Consider the trigonometric function f(t) whose graph is shown below. Write down a possible formula for f(t).

1. Consider the trigonometric function f(t) whose graph is shown below. Write down a possible formula for f(t). . Consider te trigonometric function f(t) wose grap is sown below. Write down a possible formula for f(t). Tis function appears to be an odd, periodic function tat as been sifted upwards, so we will use

More information

A Hybrid Mixed Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems

A Hybrid Mixed Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems A Hybrid Mixed Discontinuous Galerkin Finite Element Metod for Convection-Diffusion Problems Herbert Egger Joacim Scöberl We propose and analyse a new finite element metod for convection diffusion problems

More information

FINITE ELEMENT APPROXIMATIONS AND THE DIRICHLET PROBLEM FOR SURFACES OF PRESCRIBED MEAN CURVATURE

FINITE ELEMENT APPROXIMATIONS AND THE DIRICHLET PROBLEM FOR SURFACES OF PRESCRIBED MEAN CURVATURE FINITE ELEMENT APPROXIMATIONS AND THE DIRICHLET PROBLEM FOR SURFACES OF PRESCRIBED MEAN CURVATURE GERHARD DZIUK AND JOHN E. HUTCHINSON Abstract. We give a finite element procedure for te Diriclet Problem

More information

du(l) 5 dl = U(0) = 1 and 1.) Substitute for U an unspecified trial function into governing equation, i.e. dx + = =

du(l) 5 dl = U(0) = 1 and 1.) Substitute for U an unspecified trial function into governing equation, i.e. dx + = = Consider an ODE of te form: Finite Element Metod du fu g d + wit te following Boundary Conditions: U(0) and du(l) 5 dl.) Substitute for U an unspecified trial function into governing equation, i.e. ^ U

More information

4. The slope of the line 2x 7y = 8 is (a) 2/7 (b) 7/2 (c) 2 (d) 2/7 (e) None of these.

4. The slope of the line 2x 7y = 8 is (a) 2/7 (b) 7/2 (c) 2 (d) 2/7 (e) None of these. Mat 11. Test Form N Fall 016 Name. Instructions. Te first eleven problems are wort points eac. Te last six problems are wort 5 points eac. For te last six problems, you must use relevant metods of algebra

More information

MVT and Rolle s Theorem

MVT and Rolle s Theorem AP Calculus CHAPTER 4 WORKSHEET APPLICATIONS OF DIFFERENTIATION MVT and Rolle s Teorem Name Seat # Date UNLESS INDICATED, DO NOT USE YOUR CALCULATOR FOR ANY OF THESE QUESTIONS In problems 1 and, state

More information

MANY scientific and engineering problems can be

MANY scientific and engineering problems can be A Domain Decomposition Metod using Elliptical Arc Artificial Boundary for Exterior Problems Yajun Cen, and Qikui Du Abstract In tis paper, a Diriclet-Neumann alternating metod using elliptical arc artificial

More information

FINITE ELEMENT EXTERIOR CALCULUS FOR PARABOLIC EVOLUTION PROBLEMS ON RIEMANNIAN HYPERSURFACES

FINITE ELEMENT EXTERIOR CALCULUS FOR PARABOLIC EVOLUTION PROBLEMS ON RIEMANNIAN HYPERSURFACES FINITE ELEMENT EXTERIOR CALCULUS FOR PARABOLIC EVOLUTION PROBLEMS ON RIEMANNIAN HYPERSURFACES MICHAEL HOLST AND CHRIS TIEE ABSTRACT. Over te last ten years, te Finite Element Exterior Calculus (FEEC) as

More information

= 0 and states ''hence there is a stationary point'' All aspects of the proof dx must be correct (c)

= 0 and states ''hence there is a stationary point'' All aspects of the proof dx must be correct (c) Paper 1: Pure Matematics 1 Mark Sceme 1(a) (i) (ii) d d y 3 1x 4x x M1 A1 d y dx 1.1b 1.1b 36x 48x A1ft 1.1b Substitutes x = into teir dx (3) 3 1 4 Sows d y 0 and states ''ence tere is a stationary point''

More information

Smoothness of solutions with respect to multi-strip integral boundary conditions for nth order ordinary differential equations

Smoothness of solutions with respect to multi-strip integral boundary conditions for nth order ordinary differential equations 396 Nonlinear Analysis: Modelling and Control, 2014, Vol. 19, No. 3, 396 412 ttp://dx.doi.org/10.15388/na.2014.3.6 Smootness of solutions wit respect to multi-strip integral boundary conditions for nt

More information

MIXED DISCONTINUOUS GALERKIN APPROXIMATION OF THE MAXWELL OPERATOR. SIAM J. Numer. Anal., Vol. 42 (2004), pp

MIXED DISCONTINUOUS GALERKIN APPROXIMATION OF THE MAXWELL OPERATOR. SIAM J. Numer. Anal., Vol. 42 (2004), pp MIXED DISCONTINUOUS GALERIN APPROXIMATION OF THE MAXWELL OPERATOR PAUL HOUSTON, ILARIA PERUGIA, AND DOMINI SCHÖTZAU SIAM J. Numer. Anal., Vol. 4 (004), pp. 434 459 Abstract. We introduce and analyze a

More information

Semigroups of Operators

Semigroups of Operators Lecture 11 Semigroups of Operators In tis Lecture we gater a few notions on one-parameter semigroups of linear operators, confining to te essential tools tat are needed in te sequel. As usual, X is a real

More information

1 Lecture 13: The derivative as a function.

1 Lecture 13: The derivative as a function. 1 Lecture 13: Te erivative as a function. 1.1 Outline Definition of te erivative as a function. efinitions of ifferentiability. Power rule, erivative te exponential function Derivative of a sum an a multiple

More information

Effect of Numerical Integration on Meshless Methods

Effect of Numerical Integration on Meshless Methods Effect of Numerical Integration on Mesless Metods Ivo Babuška Uday Banerjee Jon E. Osborn Qingui Zang Abstract In tis paper, we present te effect of numerical integration on mesless metods wit sape functions

More information

Math Spring 2013 Solutions to Assignment # 3 Completion Date: Wednesday May 15, (1/z) 2 (1/z 1) 2 = lim

Math Spring 2013 Solutions to Assignment # 3 Completion Date: Wednesday May 15, (1/z) 2 (1/z 1) 2 = lim Mat 311 - Spring 013 Solutions to Assignment # 3 Completion Date: Wednesday May 15, 013 Question 1. [p 56, #10 (a)] 4z Use te teorem of Sec. 17 to sow tat z (z 1) = 4. We ave z 4z (z 1) = z 0 4 (1/z) (1/z

More information

A Mixed-Hybrid-Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems

A Mixed-Hybrid-Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems A Mixed-Hybrid-Discontinuous Galerkin Finite Element Metod for Convection-Diffusion Problems Herbert Egger Joacim Scöberl We propose and analyse a new finite element metod for convection diffusion problems

More information

Taylor Series and the Mean Value Theorem of Derivatives

Taylor Series and the Mean Value Theorem of Derivatives 1 - Taylor Series and te Mean Value Teorem o Derivatives Te numerical solution o engineering and scientiic problems described by matematical models oten requires solving dierential equations. Dierential

More information

Key words. Finite element method; convection-diffusion-reaction; nonnegativity; boundedness

Key words. Finite element method; convection-diffusion-reaction; nonnegativity; boundedness PRESERVING NONNEGATIVITY OF AN AFFINE FINITE ELEMENT APPROXIMATION FOR A CONVECTION-DIFFUSION-REACTION PROBLEM JAVIER RUIZ-RAMÍREZ Abstract. An affine finite element sceme approximation of a time dependent

More information

Subdifferentials of convex functions

Subdifferentials of convex functions Subdifferentials of convex functions Jordan Bell jordan.bell@gmail.com Department of Matematics, University of Toronto April 21, 2014 Wenever we speak about a vector space in tis note we mean a vector

More information

Stability properties of a family of chock capturing methods for hyperbolic conservation laws

Stability properties of a family of chock capturing methods for hyperbolic conservation laws Proceedings of te 3rd IASME/WSEAS Int. Conf. on FLUID DYNAMICS & AERODYNAMICS, Corfu, Greece, August 0-, 005 (pp48-5) Stability properties of a family of cock capturing metods for yperbolic conservation

More information

CONSTRUCTIVELY WELL-POSED APPROXIMATION METHODS WITH UNITY INF SUP AND CONTINUITY CONSTANTS FOR PARTIAL DIFFERENTIAL EQUATIONS

CONSTRUCTIVELY WELL-POSED APPROXIMATION METHODS WITH UNITY INF SUP AND CONTINUITY CONSTANTS FOR PARTIAL DIFFERENTIAL EQUATIONS MATHEMATICS OF COMPUTATION Volume 82, Number 284, October 203, Pages 923 952 S 0025-578(203)02697-X Article electronically publised on April 23, 203 CONSTRUCTIVELY WELL-POSED APPROXIMATION METHODS WITH

More information

Hilbert-Space Integration

Hilbert-Space Integration Hilbert-Space Integration. Introduction. We often tink of a PDE, like te eat equation u t u xx =, a an evolution equation a itorically wa done for ODE. In te eat equation example two pace derivative are

More information

POLYNOMIAL AND SPLINE ESTIMATORS OF THE DISTRIBUTION FUNCTION WITH PRESCRIBED ACCURACY

POLYNOMIAL AND SPLINE ESTIMATORS OF THE DISTRIBUTION FUNCTION WITH PRESCRIBED ACCURACY APPLICATIONES MATHEMATICAE 36, (29), pp. 2 Zbigniew Ciesielski (Sopot) Ryszard Zieliński (Warszawa) POLYNOMIAL AND SPLINE ESTIMATORS OF THE DISTRIBUTION FUNCTION WITH PRESCRIBED ACCURACY Abstract. Dvoretzky

More information

Mathematics 123.3: Solutions to Lab Assignment #5

Mathematics 123.3: Solutions to Lab Assignment #5 Matematics 3.3: Solutions to Lab Assignment #5 Find te derivative of te given function using te definition of derivative. State te domain of te function and te domain of its derivative..: f(x) 6 x Solution:

More information

Section 3: The Derivative Definition of the Derivative

Section 3: The Derivative Definition of the Derivative Capter 2 Te Derivative Business Calculus 85 Section 3: Te Derivative Definition of te Derivative Returning to te tangent slope problem from te first section, let's look at te problem of finding te slope

More information

(a) At what number x = a does f have a removable discontinuity? What value f(a) should be assigned to f at x = a in order to make f continuous at a?

(a) At what number x = a does f have a removable discontinuity? What value f(a) should be assigned to f at x = a in order to make f continuous at a? Solutions to Test 1 Fall 016 1pt 1. Te grap of a function f(x) is sown at rigt below. Part I. State te value of eac limit. If a limit is infinite, state weter it is or. If a limit does not exist (but is

More information

Adaptive Finite Element Method

Adaptive Finite Element Method 39 Capter 3 Adaptive inite Element Metod 31 Introduction As already pointed out in capter 2, singularities occur in interface problems Wen discretizing te problem (221) wit inite Elements, te singularities

More information

Exam 1 Review Solutions

Exam 1 Review Solutions Exam Review Solutions Please also review te old quizzes, and be sure tat you understand te omework problems. General notes: () Always give an algebraic reason for your answer (graps are not sufficient),

More information

ERROR BOUNDS FOR THE METHODS OF GLIMM, GODUNOV AND LEVEQUE BRADLEY J. LUCIER*

ERROR BOUNDS FOR THE METHODS OF GLIMM, GODUNOV AND LEVEQUE BRADLEY J. LUCIER* EO BOUNDS FO THE METHODS OF GLIMM, GODUNOV AND LEVEQUE BADLEY J. LUCIE* Abstract. Te expected error in L ) attimet for Glimm s sceme wen applied to a scalar conservation law is bounded by + 2 ) ) /2 T

More information

Different Approaches to a Posteriori Error Analysis of the Discontinuous Galerkin Method

Different Approaches to a Posteriori Error Analysis of the Discontinuous Galerkin Method WDS'10 Proceedings of Contributed Papers, Part I, 151 156, 2010. ISBN 978-80-7378-139-2 MATFYZPRESS Different Approaces to a Posteriori Error Analysis of te Discontinuous Galerkin Metod I. Šebestová Carles

More information

New Streamfunction Approach for Magnetohydrodynamics

New Streamfunction Approach for Magnetohydrodynamics New Streamfunction Approac for Magnetoydrodynamics Kab Seo Kang Brooaven National Laboratory, Computational Science Center, Building 63, Room, Upton NY 973, USA. sang@bnl.gov Summary. We apply te finite

More information

. If lim. x 2 x 1. f(x+h) f(x)

. If lim. x 2 x 1. f(x+h) f(x) Review of Differential Calculus Wen te value of one variable y is uniquely determined by te value of anoter variable x, ten te relationsip between x and y is described by a function f tat assigns a value

More information

Lecture 15. Interpolation II. 2 Piecewise polynomial interpolation Hermite splines

Lecture 15. Interpolation II. 2 Piecewise polynomial interpolation Hermite splines Lecture 5 Interpolation II Introduction In te previous lecture we focused primarily on polynomial interpolation of a set of n points. A difficulty we observed is tat wen n is large, our polynomial as to

More information

More on generalized inverses of partitioned matrices with Banachiewicz-Schur forms

More on generalized inverses of partitioned matrices with Banachiewicz-Schur forms More on generalized inverses of partitioned matrices wit anaciewicz-scur forms Yongge Tian a,, Yosio Takane b a Cina Economics and Management cademy, Central University of Finance and Economics, eijing,

More information

CS522 - Partial Di erential Equations

CS522 - Partial Di erential Equations CS5 - Partial Di erential Equations Tibor Jánosi April 5, 5 Numerical Di erentiation In principle, di erentiation is a simple operation. Indeed, given a function speci ed as a closed-form formula, its

More information

On convergence of the immersed boundary method for elliptic interface problems

On convergence of the immersed boundary method for elliptic interface problems On convergence of te immersed boundary metod for elliptic interface problems Zilin Li January 26, 2012 Abstract Peskin s Immersed Boundary (IB) metod is one of te most popular numerical metods for many

More information