One dimension and tensor products. 2.1 Legendre and Jacobi polynomials

Size: px
Start display at page:

Download "One dimension and tensor products. 2.1 Legendre and Jacobi polynomials"

Transcription

1 Part I, Chapter 2 One dimension and tensor products This chapter presents important examples of finite elements, first in one space dimension, then in multiple space dimensions using tensor product techniques. Important computational issues related to the manipulation of high-order polynomial bases are addressed. (JLG) revised again Feb 9, 26, 22:33 2. Legendre and Jacobi polynomials This section reviews some basic properties of the Legendre and Jacobi polynomials which are often used in the design of high-order finite elements. Definition 2. (Legendre polynomials). The Legendre polynomials are univariate polynomial functions R R defined by L m(t) = ()m 2 m m! for all t R and all m 0. d m dt m(( t)m (+t) m ), (2.) Thesuperscript referstothefollowingimportantorthogonalityproperty. Proposition 2.2 (L 2 -orthogonality). The Legendre polynomials are L 2 - orthogonal over the interval (, ), and the following holds: L m(t)l n(t)dt = Proof. Use induction and integration by parts. 2 2m+ δ mn, m,n 0. (2.2) Legendre polynomials satisfy many other properties. We now list some of the most important ones. The following Bonnet s recursion formula holds: (m+)l m+(t) = (2m+)tL m(t) ml m(t), m.

2 6 Chapter 2. One dimension and tensor products L m is a polynomial of degree m and L m() = () m, L m() =. The m roots of L m are in (,) and are called Gauss Legendre nodes; they play an important role in the design of quadratures; see Chapter 56. The first four Legendre polynomials are L 0 (t) =, L (t) = t, L 2 (t) = 2 (3t2 ), and their graphs are shown in Figure 2.. L 3 (t) = 2 (5t3 3t), Fig. 2.. Legendre polynomials of degree at most 3 in the interval [,]. Definition 2.3 (Jacobi polynomials). Let α,β R be such that α > and β >. The Jacobi polynomials are univariate polynomial functions R R defined by Jm α,β ( (t) = ()m 2 m m! ( t) α β dm (+t) dt ( t) α+m (+t) β+m), (2.3) m for all t R and all m 0. The Jacobi polynomials satisfy the following L 2 -orthogonality property on the interval (, ): ( t) α (+t) β J α,β with c m,α,β = 2α+β+ 2m+α+β+ m (t)j α,β n (t)dt = c m,α,β δ mn, m,n 0, (2.4) Γ(m+α+)Γ(m+β+) m!γ(m+α+β+), where Γ is the Gamma function (recall that Γ(n+) = n! for any natural number n). The Jacobi polynomials satisfy the following recursion formula for all m : 2(m+)(m+α+β +)(2m+α+β)J α,β m+ (t) = (2m+α+β +)((2m+α+β +2)(2m+α+β)t+α 2 β 2 )J α,β m (t) 2(m+α)(m+β)(2m+α+β +2)J α,β m (t).

3 Part I. Getting Started 7 Jm α,β is a polynomial of degree m and Jm α,β () = () m( ) m+β m, J α,β m () = ( m+α ) m. The Legendre polynomials are Jacobi polynomials with parameters α = β = 0, i.e., L m(t) = Jm 0,0 (t) for all m 0. The first three Jacobi polynomials corresponding to the parameters α = β = are J, 0 (t) =, J, (t) = 2t, J, 2 (t) = 3 4 (5t2 ) The Jacobi polynomials J, m are related to the integrated Legendre polynomials as follows (see Exercise 2.4): t L m(s)ds = 2m ( t2 )J, m (t), m. (2.5) We refer to Abramowitz and Stegun [, Chap. 22] for further results. 2.2 One-dimensional finite elements In this section, we present important examples of one-dimensional finite elements. Recall that P k, k 0, is the real vector space composed of univariate polynomial functions of degree at most k. For convenience, degrees of freedom and shape functions of one-dimensional finite elements using the polynomial space P k are numbered from 0 to k Lagrange (nodal) finite elements Following Definition.8, the degrees of freedom for Lagrange finite elements are chosen as the values at some set of nodes. Proposition 2.4 (Lagrange finite element). Let k 0. Let K be a compact interval with non-empty interior, and let P = P k. Consider a set of n sh = k+ distinct nodes {a l } l {0:k} in K. Let Σ = {σ l } l {0:k} be the linear forms on P such that σ l (p) = p(a l ) for all l {0:k}. Then, (K,P,Σ) is a Lagrange finite element. Proof. We verify unisolvence. We observe that dimp = k+ = n sh = cardσ and that a polynomial p P such that σ l (p) = p(a l ) = 0 for all l {0:k} is of degree at most k and has (k +) distinct roots. Hence, p 0. The shape functions of a one-dimensional Lagrange finite element are the Lagrange interpolation polynomials {L [a] l } i {0:k} defined as in (.2). Following (.0), the Lagrange interpolation operator acts as follows: IK(v)(t) L = v(a l )L [a] l (t), t K, (2.6) l {0: k}

4 8 Chapter 2. One dimension and tensor products and possible choices for the domain of I L K are V(K) = C0 (K) or V(K) = W, (K), see Exercise.7. The Lagrange interpolation polynomials based on equidistant nodes (including both endpoints) in the interval K = [, ] are henceforth denoted {L k l } l {0:k}. The graphs of these polynomials are illustrated in Figure. for k {,2,3}, and explicit expressions are as follows: L 0(t) = 2 ( t), L2 0(t) = 2 t(t), L3 0(t) = 9 6 (t+ 3 )(t 3 )( t), L (t) = 2 (+t), L2 (t) = (t+)( t), L 3 (t) = 27 6 (t+)(t 3 )(t), L 2 2(t) = 2 (t+)t, L3 2(t) = 27 6 (t+)(t+ 3 )( t), L 3 3(t) = 9 6 (t+)(t+ 3 )(t 3 ). While the choice of equidistant nodes appears somewhat natural, it is appropriate only when working with low-degree polynomials, see Modal finite elements In this section, we illustrate the construction of.4.2 in the one-dimensional setting, say on the interval [, ]. Proposition 2.5 (Legendre finite element). Let k 0. Let K = [,] and let P = P k. Let Σ = {σ l } l {0:k} be the n sh = k + linear forms on P such that σ l (p) = 2l+ L l (t)p(t)dt, l {0:k}. (2.7) 2 Then, (K,P,Σ) is a finite element. The shape functions are the (k +) Legendre polynomials of degree k. Proof. Use (2.2) and Proposition.9. Following (.3), the Legendre interpolation operator acts as follows: ) L l (s)v(s)ds L l (t) for all t K and all IK m(v)(t) = l {0:k} v V(K) = L (K). ( 2l Hybrid finite elements ( ) Hybrid finite elements mix nodal and modal degrees of freedom. When constructing so-called H -conforming approximation spaces (see Chapter 3 for a full treatment in multiple space dimensions), it is important that all the basis functions but one vanish at each endpoint of the interval, say K = [,]. This calls for using the values at ± as nodal degrees of freedom on P k. For k 2, some or all of the remaining degrees of freedom can be taken to be of modal type. Taking all of them as moments against polynomials in P k 2 leads to the so-called canonical hybrid finite element; a multi-dimensional extension in a simplex is presented in 3.4.

5 Part I. Getting Started 9 Proposition 2.6 (Canonical hybrid finite element). Let k. Set K = [,] and P = P k. Define σ 0 (p) = p(), σ k (p) = p(), and, if k 2, let {µ l } l {:k} be a basis of P k 2 and define σ l (p) = K pµ lds for all l {:k}. Set Σ = {σ l } l {0:k}. Then, the triple (K,P,Σ) is a finite element. Proof. See Exercise 2.5. The corresponding interpolation operator is denoted I g K (the superscript is consistent with the notation introduced in 0.2 where the letter g refers to the gradient operator). Its action on functions v W, (K) is such that I g K (v)(±) = v(±) and (Ig K (v) v)qds = 0 for all q P k 2. Proposition 2.7 (Commuting with derivative). Let k 0. Let I g K be the interpolation operator built from the canonical hybrid finite element of order (k+). Let IK m be the interpolation operator built from the modal finite element of order k. Then, I g K (v) = IK m(v ) for all v W, (K). Proof. Integrating by parts and using the properties of the interpolation operators (i.e., (Ig K (v) v)rds = 0 for all r P k and I g K (v)(±) = v(±)), we infer that, for all q P k, I g K (v) qdt = I g K (v)q dt+[i g K (v)q] = vq dt+[vq] = v qdt = I m K(v )qdt. This proves that I g K (v) = I m K (v ) since both functions are in P k. The shape functions of the canonical hybrid finite element can be computed explicitly once a choice for the basis functions {µ l } l {:k} of P k 2 is made; an example is proposed in Exercise 2.5 using Jacobi polynomials Hierarchical bases ( ) The notion of hierarchical polynomial bases is important when working with high-order polynomials. It is particularly convenient in simulations where the degree k varies from one element to the other. Definition 2.8 (Hierarchical basis). A sequence of polynomials (P k ) k N is said to be a hierarchical polynomial basis if the set {P l } l {0:k} is a basis of P k for all k N. The monomial basis (i.e., P k (t) = t k ) is the simplest example of hierarchical polynomial basis. The Jacobi polynomials introduced in 2. form a hierarchical basis which is L 2 -orthogonal with respect to the weight ( t) α (+t) β. The Lagrange shape functions do not form a hierarchical basis, i.e., increasing k to (k+) requires to recompute the whole basis of shape functions.

6 20 Chapter 2. One dimension and tensor products Instead, the shape functions of modal elements form, by construction, a hierarchical basis. Finally, in the hybrid case, the shape functions do not form, in general, a hierarchical basis. One can obtain a hierarchical basis though by slightly modifying the degrees of freedom. For instance, the following shape functions form a hierarchical basis: θ 0 (t) = 2 ( t), θ l (t) = 4 ( t)(+t)j, l (t), l {:k }, (2.8b) θ k (t) = 2 (+t). (2.8a) (2.8c) Their degrees of freedom can be taken to be σ 0 (p) = p(), σ k (p) = p(), and σ l (p) = α l pj, l dt+β l p()+β+ l p() for all l {:k }, where α l = 4c l,,, β± l = 2c l,, (±t)j, l dt, and c l,, defined in (2.4) High-order Lagrange elements ( ) The main difficulty comes from the oscillatory nature of the Lagrange polynomials as the number of interpolation nodes grows. This phenomenon is often referred to as the Runge phenomenon [400] (see also Meray [349]). A classic example illustrating this phenomenon consists of considering the function f(x) = ( + x 2 ), x [ 5,5]; the Lagrange interpolation polynomial of f using n equidistant points over [ 5, 5] converges uniformly to f in the interval ( x c,x c ) with x c 3.63 and diverges outside this interval. The approximation quality in the maximum norm of the one-dimensional Lagrange interpolation operator using n sh = k + distinct nodes is quantified by the Lebesgue constant; see Theorem.. Since the Lebesgue constant is invariant by linear transformation of the interval K, we henceforth restrict the discussion to K = [,]. It can be shown that the Lebesgue constant for equidistant nodes grows exponentially with n sh ; more precisely, 2 n en(logn+γ) Λ nsh as n where γ =.5772 is the Euler constant; see Trefethen and Weideman [45]. A lower bound for the Lebesgue constant for any set of points is 2 π ln(n sh) C for some positive C; see Erdős [208]. If the Chebyshev nodes a l = cos( (2l)π 2n sh ), l N = {:n sh }, are used instead of the equidistant nodes, the Lebesgue constant behaves as 2 π ln(n sh)+c +α n, with C = 2 π (γ+log 8 π ) = and α n 0 as n, showing that this choice is asymptotically optimal; see Luttmann and Rivlin [340] and Rivlin [396, Chap. 4]. One drawback of Chebyshev nodes is that they do not contain the interval endpoints ±, which make them unsuitable for constructing H -conforming finite element spaces; see the discussion at the beginning of One set of interpolating nodes realizing this constraint are the Gauss Lobatto Legendre nodes, which are, for k, the (k + ) roots of the polynomial ( t)( + t)(l k ) (t); all these nodes are in [,] since all the roots of L k are in (,). The corresponding Lagrange interpolation polynomials for

7 Part I. Getting Started 2 k = 3 are shown in the left panel of Figure 2.2. The Gauss Lobatto Legendre nodes lead to an asymptotically optimal Lebesgue constant with upper bound 2 π log(n sh) + C, with C 0.685; see Hesthaven [280, Conj. 3.2] and Hesthaven et al. [28, p. 06]. Note that the Lagrange polynomial bases using the Gauss Lobatto Legendre nodes are not hierarchical since the set of n sh Gauss Lobatto Legendre nodes is not included in the set of (n sh +) nodes Fig Left: Lagrange polynomials associated with the Gauss Lobatto Legendre nodes for k = 3. Right: Hybrid nodal/modal shape functions for k = 4. Another important class of sets of nodes is that consisting of the so-called Fekete points. Fekete points are defined from a maximization problem. Let {a i } i N be a set of nodes in K = [,] and let {φ i } i N be a basis of P k (recall that N = {:n sh }). Consider the (generalized) n sh n sh Vandermonde matrix V with entries V ij = φ i (a j ), for all i,j N. Since the Lagrange polynomials can be expressed as L [a] i (t) = j N (V ) ij φ j (t) (see Exercise 2.), a reasonable criterion for selecting the interpolation nodes is to maximize the determinant of V with respect to {a i } i N (observe that the solution to this problem does not depend on the chosen basis, since a change of basis only multiplies the determinant by a factor equal to the determinant of the change of basis matrix). It is shown in Fejér [229] that the Fekete points and the Gauss Lobatto Legendre nodes coincide on any interval. The notion of Fekete points extends naturally to any space dimension, but the concept of Gauss Lobatto Legendre nodes can be extended in higher space dimensions only by invoking tensor product techniques; see 2.3.

8 22 Chapter 2. One dimension and tensor products 2.3 Tensor product elements We show in this section that the one-dimensional finite elements presented in 2.2 can be extended to higher dimensions by using tensor product techniques when K R d has the Cartesian product structure K = d i= [z i,z+ i ] with real numbers z ± i, i {:d}, such that z i < z + i. A set of this form in Rd is called a cuboid The polynomial space Q k,d A useful ingredient to build tensor-product finite elements in R d is the polynomial space Q k,d = P k... P }{{ k. (2.9) } d times Thisspaceiscomposedofd-variatepolynomialfunctionsq : R d Rofpartial degree at most k with respect to each variable. Thus, { } Q k,d = span x β...xβ d d, 0 β,...,β d k. (2.0) We omit the subscript d and simply write Q k when the context is unambiguous. Let β = (β,...,β d ) N d be a multi-index, define β l = max i {:d} β i, and consider the multi-index set B k,d = {β N d β l k}. Polynomial functions q Q k,d can be written in the following generic form: q(x) = β B k,d a β x β, x β = x β...xβ d d, (2.) with real numbers a β. Note that card(b k,d ) = dim(q k,d ) = (k +) d Tensor-product finite elements We begin with tensor-product Lagrange finite elements with nodes obtained by invoking the tensor product of nodes along each Cartesian direction. This leads to the following construction. Proposition 2.9 (Tensor-product Lagrange). Let K = d i= [z i,z+ i ] be a cuboid in R d. Let k and let P = Q k,d. For all i {:d}, consider (k+) distinct nodes {a i,l } l {0:k} in [z i,z+ i ]. For any multi-index β = (β,...,β d ) B k,d, define the node a β in K with Cartesian components (a i,βi ) i {:d}. Let Σ = {σ β } β Bk,d be the linear forms on P such that σ β (p) = p(a β ) for all β B k,d. Then, (K,P,Σ) is a Lagrange finite element. Proof. See Exercise 2.6.

9 Part I. Getting Started 23 The shape functions of a tensor-product Lagrange finite element are products of the one-dimensional Lagrange interpolation polynomials defined in (.2): θ β (x) = d i= L [ai] β i (x i ), x K, (2.2) for all β B k,d. The Lagrange interpolation operator acts as follows: I L K(v)(x) = β B k,d v(a β )θ β (x), x K, (2.3) and possible choices for its domain are V(K) = C 0 (K) or V(K) = W s,p (K) with real numbers p [, ] and s > d p. Note that, in general, IL K (v)(x) cannot be factorized as a product of univariate functions, except when the function v has the separated form v(x) = Π d i= v i(x i ) with v i C 0 ([x i,x+ i ]), in which case one can verify that I L K (v)(x) = d i= IL [x i,x+ i ](v i)(x i ). Q Q 2 Q 3 Table 2.. Two- and three-dimensional Lagrange finite elements Q, Q 2, and Q 3; only visible degrees of freedom are shown in three dimensions. Table 2. presents examples for k {, 2, 3} in dimensions d {2, 3} with equidistant nodes in each Cartesian direction. The bullets conventionally indicate the location of the nodes. It is useful to use the tensor product of Gauss Lobatto Legendre nodes when k is large, since it can be shown that the Fekete points in cuboids are the tensor products of the one-dimensional Gauss Lobatto Legendre nodes, see Bos et al. [69]. The tensor-product technique can also be used to build modal and hybrid nodal/modal finite elements in cuboids; see [69]. Following the early work of Patera [372], finite element methods based on nodal bases using tensor products are often referred to as spectral methods.

10 24 Chapter 2. One dimension and tensor products Serendipity finite elements ( ) It is possible to remove some nodes inside the cuboid while maintaining the approximation properties obtained when using full tensor products. This is the idea of the serendipity finite elements. The corresponding polynomial space, S k, is then a proper subspace of Q k. The main motivation is to reduce computational costs without sacrificing the possibility to build H -conforming finite element spaces and without sacrificing the accuracy of the interpolation operator. Classical two-dimensional examples consist of using the 8 boundary nodes for k = 2 and the 2 boundary nodes for k = 3 (see Table 2.2). For k = 4, one uses the 6 boundary nodes plus the barycenter of K. A systematic construction of the serendipity finite elements for any space dimension and polynomial degree is devised in Arnold and Awanou [6]. S 2 S 3 S 4 Table 2.2. Two-dimensional serendipity Lagrange finite elements S 2, S 3, and S 4. Exercises Exercise 2. (Vandermonde matrix). Consider the Lagrange finite element from Proposition 2.4 with nodes {a i } i N in K. Let {L [a] i } i N be the corresponding Lagrange polynomials, see (.2). Let {φ i } i N be a basis of P k. Show that the Lagrange polynomials can be written in the form L [a] i (t) = j N(V ) ij φ j (t), where the matrix V has entries V ij = φ i (a j ) for all i,j N. (Note: when the functions φ i are the monomial basis, the matrix V is called a Vandermonde matrix; otherwise, it is called a generalized Vandermonde matrix.) Exercise 2.2 (Cross approximation). Let f : X Y R be a bivariate function where X,Y are two nonempty subsets of R. Let n sh, set N = {:n sh }, and consider n sh points {x i } i N in X and n sh points {y j } j N in

11 Part I. Getting Started 25 Y. Assume that the matrix F R n sh n sh with entries F ij = f(x i,y j ) is invertible. Let I CA (f) : X Y R be defined by I CA (f)(x,y) = (F T ) ij f(x,y j )f(x i,y). i,j N Prove that I CA (f)(x,y k ) = f(x,y k ) for all x X and all k N, and that I CA (f)(x k,y) = f(x k,y) for all y Y and all k N. Exercise 2.3 (Mass and Vandermonde matrices). Let K = [,], let {a,...,a nsh } be nodes in K, and let {L [a] i } i nsh be the corresponding Lagrange polynomials. Let M R n sh n sh be the so-called mass matrix with entries M ij = L[a] i (t)l [a] j (t)dt for all i,j N. Prove that M = (VT V) where V R n sh n sh is the (generalized) Vandermonde matrix with entries V ij = ( 2 2i )/2 L i (a j) and the L i s are the Legendre polynomials (see Definition 2.). Exercise 2.4 (Integrated Legendre polynomials). Let k 2 and set P (0) k = {p P k p(±) = 0}. (i) Show that a basis for P (0) k are the integrated Legendre polynomials { t L l (s)ds} l {:k}. (ii) Prove (2.5). (Hint: consider moments against polynomials in P m 2 and the derivative at t =.) Exercise 2.5 (Canonical hybrid element). (i) Prove Proposition 2.6. (Hint: verify unisolvence.) (ii) Compute the shape functions when µ l = J, l for all l {:k}. (Hint: consider the polynomials J,0, l {:k }, and J0, k, J, l k.) Exercise 2.6 (Q k,d Lagrange). Prove Proposition 2.9. (Hint: observe that any polynomial p Q k,d can be written p(x) = k i d =0 q i d (x,...,x d )x i d d and use induction on d.) Exercise 2.7 (Bi-cubic Hermite rectangle). Let K be a (non-degenerate) rectangle with vertices {z,z 2,z 3,z 4 }. Set P = Q 3,2 and Σ = {p(z i ), x p(z i ), x2 p(z i ), 2 x x 2 p(z i )} i 4. Show that (K,P,Σ) is a finite element. (Hint: write p Q 3,2 in the form p(x) = i,j 4 γ ijθ i (x )θ j (x 2 ) where {θ,...,θ 4 } are the shape functions of the one-dimensional Hermite finite element; see Exercise.3.)

Finite Element Interpolation

Finite Element Interpolation Finite Element Interpolation This chapter introduces the concept of finite elements along with the corresponding interpolation techniques. As an introductory example, we study how to interpolate functions

More information

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

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

More information

Interpolation. Chapter Interpolation. 7.2 Existence, Uniqueness and conditioning

Interpolation. Chapter Interpolation. 7.2 Existence, Uniqueness and conditioning 76 Chapter 7 Interpolation 7.1 Interpolation Definition 7.1.1. Interpolation of a given function f defined on an interval [a,b] by a polynomial p: Given a set of specified points {(t i,y i } n with {t

More information

Scientific Computing: An Introductory Survey

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

More information

Numerical Methods I: Polynomial Interpolation

Numerical Methods I: Polynomial Interpolation 1/31 Numerical Methods I: Polynomial Interpolation Georg Stadler Courant Institute, NYU stadler@cims.nyu.edu November 16, 2017 lassical polynomial interpolation Given f i := f(t i ), i =0,...,n, we would

More information

Improved Lebesgue constants on the triangle

Improved Lebesgue constants on the triangle Journal of Computational Physics 207 (2005) 625 638 www.elsevier.com/locate/jcp Improved Lebesgue constants on the triangle Wilhelm Heinrichs Universität Duisburg-Essen, Ingenieurmathematik (FB 10), Universitätsstrasse

More information

Polynomial Interpolation Part II

Polynomial Interpolation Part II Polynomial Interpolation Part II Prof. Dr. Florian Rupp German University of Technology in Oman (GUtech) Introduction to Numerical Methods for ENG & CS (Mathematics IV) Spring Term 2016 Exercise Session

More information

Lecture Note 3: Polynomial Interpolation. Xiaoqun Zhang Shanghai Jiao Tong University

Lecture Note 3: Polynomial Interpolation. Xiaoqun Zhang Shanghai Jiao Tong University Lecture Note 3: Polynomial Interpolation Xiaoqun Zhang Shanghai Jiao Tong University Last updated: October 24, 2013 1.1 Introduction We first look at some examples. Lookup table for f(x) = 2 π x 0 e x2

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 the understanding that it is not to be used for financial gain, and may be downloaded and/or photocopied,

More information

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

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

More information

Chapter 2 Definition of Different Types of Finite Elements

Chapter 2 Definition of Different Types of Finite Elements Chapter 2 Definition of Different Types of Finite Elements Abstract This chapter presents a wide variety of finite elements of different shapes (quadrilaterals, hexahedra, triangles, tetrahedra, pyramids

More information

Class notes: Approximation

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

More information

Lecture 10 Polynomial interpolation

Lecture 10 Polynomial interpolation Lecture 10 Polynomial interpolation Weinan E 1,2 and Tiejun Li 2 1 Department of Mathematics, Princeton University, weinan@princeton.edu 2 School of Mathematical Sciences, Peking University, tieli@pku.edu.cn

More information

MATH 205C: STATIONARY PHASE LEMMA

MATH 205C: STATIONARY PHASE LEMMA MATH 205C: STATIONARY PHASE LEMMA For ω, consider an integral of the form I(ω) = e iωf(x) u(x) dx, where u Cc (R n ) complex valued, with support in a compact set K, and f C (R n ) real valued. Thus, I(ω)

More information

Numerical Solutions to Partial Differential Equations

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

More information

Lecture Note 3: Interpolation and Polynomial Approximation. Xiaoqun Zhang Shanghai Jiao Tong University

Lecture Note 3: Interpolation and Polynomial Approximation. Xiaoqun Zhang Shanghai Jiao Tong University Lecture Note 3: Interpolation and Polynomial Approximation Xiaoqun Zhang Shanghai Jiao Tong University Last updated: October 10, 2015 2 Contents 1.1 Introduction................................ 3 1.1.1

More information

Numerical Analysis: Interpolation Part 1

Numerical Analysis: Interpolation Part 1 Numerical Analysis: Interpolation Part 1 Computer Science, Ben-Gurion University (slides based mostly on Prof. Ben-Shahar s notes) 2018/2019, Fall Semester BGU CS Interpolation (ver. 1.00) AY 2018/2019,

More information

ON A WEIGHTED INTERPOLATION OF FUNCTIONS WITH CIRCULAR MAJORANT

ON A WEIGHTED INTERPOLATION OF FUNCTIONS WITH CIRCULAR MAJORANT ON A WEIGHTED INTERPOLATION OF FUNCTIONS WITH CIRCULAR MAJORANT Received: 31 July, 2008 Accepted: 06 February, 2009 Communicated by: SIMON J SMITH Department of Mathematics and Statistics La Trobe University,

More information

Lectures 9-10: Polynomial and piecewise polynomial interpolation

Lectures 9-10: Polynomial and piecewise polynomial interpolation Lectures 9-1: Polynomial and piecewise polynomial interpolation Let f be a function, which is only known at the nodes x 1, x,, x n, ie, all we know about the function f are its values y j = f(x j ), j

More information

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

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

More information

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

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

More information

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

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

More information

π X : X Y X and π Y : X Y Y

π X : X Y X and π Y : X Y Y Math 6130 Notes. Fall 2002. 6. Hausdorffness and Compactness. We would like to be able to say that all quasi-projective varieties are Hausdorff and that projective varieties are the only compact varieties.

More information

Interpolation. 1. Judd, K. Numerical Methods in Economics, Cambridge: MIT Press. Chapter

Interpolation. 1. Judd, K. Numerical Methods in Economics, Cambridge: MIT Press. Chapter Key References: Interpolation 1. Judd, K. Numerical Methods in Economics, Cambridge: MIT Press. Chapter 6. 2. Press, W. et. al. Numerical Recipes in C, Cambridge: Cambridge University Press. Chapter 3

More information

A Lobatto interpolation grid in the tetrahedron

A Lobatto interpolation grid in the tetrahedron IMA Journal of Applied Mathematics Advance Access published January 12, 2006 IMA Journal of Applied Mathematics (2006) 1 16 doi:10.1093/imamat/hxh111 A Lobatto interpolation grid in the tetrahedron H.

More information

WRT in 2D: Poisson Example

WRT in 2D: Poisson Example WRT in 2D: Poisson Example Consider 2 u f on [, L x [, L y with u. WRT: For all v X N, find u X N a(v, u) such that v u dv v f dv. Follows from strong form plus integration by parts: ( ) 2 u v + 2 u dx

More information

CIV-E1060 Engineering Computation and Simulation Examination, December 12, 2017 / Niiranen

CIV-E1060 Engineering Computation and Simulation Examination, December 12, 2017 / Niiranen CIV-E16 Engineering Computation and Simulation Examination, December 12, 217 / Niiranen This examination consists of 3 problems rated by the standard scale 1...6. Problem 1 Let us consider a long and tall

More information

Bivariate Lagrange interpolation at the Padua points: The generating curve approach

Bivariate Lagrange interpolation at the Padua points: The generating curve approach Journal of Approximation Theory 43 (6) 5 5 www.elsevier.com/locate/jat Bivariate Lagrange interpolation at the Padua points: The generating curve approach Len Bos a, Marco Caliari b, Stefano De Marchi

More information

A matrix over a field F is a rectangular array of elements from F. The symbol

A matrix over a field F is a rectangular array of elements from F. The symbol Chapter MATRICES Matrix arithmetic A matrix over a field F is a rectangular array of elements from F The symbol M m n (F ) denotes the collection of all m n matrices over F Matrices will usually be denoted

More information

Scientific Computing

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

More information

Math 321: Linear Algebra

Math 321: Linear Algebra Math 32: Linear Algebra T. Kapitula Department of Mathematics and Statistics University of New Mexico September 8, 24 Textbook: Linear Algebra,by J. Hefferon E-mail: kapitula@math.unm.edu Prof. Kapitula,

More information

Here each term has degree 2 (the sum of exponents is 2 for all summands). A quadratic form of three variables looks as

Here each term has degree 2 (the sum of exponents is 2 for all summands). A quadratic form of three variables looks as Reading [SB], Ch. 16.1-16.3, p. 375-393 1 Quadratic Forms A quadratic function f : R R has the form f(x) = a x. Generalization of this notion to two variables is the quadratic form Q(x 1, x ) = a 11 x

More information

University of Houston, Department of Mathematics Numerical Analysis, Fall 2005

University of Houston, Department of Mathematics Numerical Analysis, Fall 2005 4 Interpolation 4.1 Polynomial interpolation Problem: LetP n (I), n ln, I := [a,b] lr, be the linear space of polynomials of degree n on I, P n (I) := { p n : I lr p n (x) = n i=0 a i x i, a i lr, 0 i

More information

Polynomial Interpolation

Polynomial Interpolation Chapter Polynomial Interpolation. Introduction Suppose that we have a two sets of n + real numbers {x i } n+ i= and {y i} n+ i=, and that the x i are strictly increasing: x < x < x 2 < < x n. Interpolation

More information

1 Linear transformations; the basics

1 Linear transformations; the basics Linear Algebra Fall 2013 Linear Transformations 1 Linear transformations; the basics Definition 1 Let V, W be vector spaces over the same field F. A linear transformation (also known as linear map, or

More information

On Multivariate Newton Interpolation at Discrete Leja Points

On Multivariate Newton Interpolation at Discrete Leja Points On Multivariate Newton Interpolation at Discrete Leja Points L. Bos 1, S. De Marchi 2, A. Sommariva 2, M. Vianello 2 September 25, 2011 Abstract The basic LU factorization with row pivoting, applied to

More information

Nodal bases for the serendipity family of finite elements

Nodal bases for the serendipity family of finite elements Foundations of Computational Mathematics manuscript No. (will be inserted by the editor) Nodal bases for the serendipity family of finite elements Michael S. Floater Andrew Gillette Received: date / Accepted:

More information

Summer Algebraic Geometry Seminar

Summer Algebraic Geometry Seminar Summer Algebraic Geometry Seminar Lectures by Bart Snapp About This Document These lectures are based on Chapters 1 and 2 of An Invitation to Algebraic Geometry by Karen Smith et al. 1 Affine Varieties

More information

m We can similarly replace any pair of complex conjugate eigenvalues with 2 2 real blocks. = R

m We can similarly replace any pair of complex conjugate eigenvalues with 2 2 real blocks. = R 1 RODICA D. COSTIN Suppose that some eigenvalues are not real. Then the matrices S and are not real either, and the diagonalization of M must be done in C n. Suppose that we want to work in R n only. Recall

More information

2. Polynomial interpolation

2. Polynomial interpolation 2. Polynomial interpolation Contents 2. POLYNOMIAL INTERPOLATION... 1 2.1 TYPES OF INTERPOLATION... 1 2.2 LAGRANGE ONE-DIMENSIONAL INTERPOLATION... 2 2.3 NATURAL COORDINATES*... 15 2.4 HERMITE ONE-DIMENSIONAL

More information

AIMS Exercise Set # 1

AIMS Exercise Set # 1 AIMS Exercise Set #. Determine the form of the single precision floating point arithmetic used in the computers at AIMS. What is the largest number that can be accurately represented? What is the smallest

More information

12.0 Properties of orthogonal polynomials

12.0 Properties of orthogonal polynomials 12.0 Properties of orthogonal polynomials In this section we study orthogonal polynomials to use them for the construction of quadrature formulas investigate projections on polynomial spaces and their

More information

256 Summary. D n f(x j ) = f j+n f j n 2n x. j n=1. α m n = 2( 1) n (m!) 2 (m n)!(m + n)!. PPW = 2π k x 2 N + 1. i=0?d i,j. N/2} N + 1-dim.

256 Summary. D n f(x j ) = f j+n f j n 2n x. j n=1. α m n = 2( 1) n (m!) 2 (m n)!(m + n)!. PPW = 2π k x 2 N + 1. i=0?d i,j. N/2} N + 1-dim. 56 Summary High order FD Finite-order finite differences: Points per Wavelength: Number of passes: D n f(x j ) = f j+n f j n n x df xj = m α m dx n D n f j j n= α m n = ( ) n (m!) (m n)!(m + n)!. PPW =

More information

Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions

Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions Bernhard Hientzsch Courant Institute of Mathematical Sciences, New York University, 51 Mercer Street, New

More information

Vector Spaces. Chapter 1

Vector Spaces. Chapter 1 Chapter 1 Vector Spaces Linear algebra is the study of linear maps on finite-dimensional vector spaces. Eventually we will learn what all these terms mean. In this chapter we will define vector spaces

More information

Elementary maths for GMT

Elementary maths for GMT Elementary maths for GMT Linear Algebra Part 2: Matrices, Elimination and Determinant m n matrices The system of m linear equations in n variables x 1, x 2,, x n a 11 x 1 + a 12 x 2 + + a 1n x n = b 1

More information

Chapter 1. Preliminaries. The purpose of this chapter is to provide some basic background information. Linear Space. Hilbert Space.

Chapter 1. Preliminaries. The purpose of this chapter is to provide some basic background information. Linear Space. Hilbert Space. Chapter 1 Preliminaries The purpose of this chapter is to provide some basic background information. Linear Space Hilbert Space Basic Principles 1 2 Preliminaries Linear Space The notion of linear space

More information

MATHEMATICS. Course Syllabus. Section A: Linear Algebra. Subject Code: MA. Course Structure. Ordinary Differential Equations

MATHEMATICS. Course Syllabus. Section A: Linear Algebra. Subject Code: MA. Course Structure. Ordinary Differential Equations MATHEMATICS Subject Code: MA Course Structure Sections/Units Section A Section B Section C Linear Algebra Complex Analysis Real Analysis Topics Section D Section E Section F Section G Section H Section

More information

Permutations and Polynomials Sarah Kitchen February 7, 2006

Permutations and Polynomials Sarah Kitchen February 7, 2006 Permutations and Polynomials Sarah Kitchen February 7, 2006 Suppose you are given the equations x + y + z = a and 1 x + 1 y + 1 z = 1 a, and are asked to prove that one of x,y, and z is equal to a. We

More information

G1110 & 852G1 Numerical Linear Algebra

G1110 & 852G1 Numerical Linear Algebra The University of Sussex Department of Mathematics G & 85G Numerical Linear Algebra Lecture Notes Autumn Term Kerstin Hesse (w aw S w a w w (w aw H(wa = (w aw + w Figure : Geometric explanation of the

More information

October 4, 2017 EIGENVALUES AND EIGENVECTORS. APPLICATIONS

October 4, 2017 EIGENVALUES AND EIGENVECTORS. APPLICATIONS October 4, 207 EIGENVALUES AND EIGENVECTORS. APPLICATIONS RODICA D. COSTIN Contents 4. Eigenvalues and Eigenvectors 3 4.. Motivation 3 4.2. Diagonal matrices 3 4.3. Example: solving linear differential

More information

On the Lebesgue constant of barycentric rational interpolation at equidistant nodes

On the Lebesgue constant of barycentric rational interpolation at equidistant nodes On the Lebesgue constant of barycentric rational interpolation at equidistant nodes by Len Bos, Stefano De Marchi, Kai Hormann and Georges Klein Report No. 0- May 0 Université de Fribourg (Suisse Département

More information

8. Diagonalization.

8. Diagonalization. 8. Diagonalization 8.1. Matrix Representations of Linear Transformations Matrix of A Linear Operator with Respect to A Basis We know that every linear transformation T: R n R m has an associated standard

More information

a 11 x 1 + a 12 x a 1n x n = b 1 a 21 x 1 + a 22 x a 2n x n = b 2.

a 11 x 1 + a 12 x a 1n x n = b 1 a 21 x 1 + a 22 x a 2n x n = b 2. Chapter 1 LINEAR EQUATIONS 11 Introduction to linear equations A linear equation in n unknowns x 1, x,, x n is an equation of the form a 1 x 1 + a x + + a n x n = b, where a 1, a,, a n, b are given real

More information

A comparison of interpolation grids over the triangle or the tetrahedron

A comparison of interpolation grids over the triangle or the tetrahedron J Eng Math (2006) 56:263 272 DOI 0.007/s0665-006-9063-0 ORIGINAL PAPER A comparison of interpolation grids over the triangle or the tetrahedron M. G. Blyth H. Luo C. Pozrikidis Received: 22 November 2005

More information

Chapter 4: Interpolation and Approximation. October 28, 2005

Chapter 4: Interpolation and Approximation. October 28, 2005 Chapter 4: Interpolation and Approximation October 28, 2005 Outline 1 2.4 Linear Interpolation 2 4.1 Lagrange Interpolation 3 4.2 Newton Interpolation and Divided Differences 4 4.3 Interpolation Error

More information

PART IV Spectral Methods

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

More information

September 26, 2017 EIGENVALUES AND EIGENVECTORS. APPLICATIONS

September 26, 2017 EIGENVALUES AND EIGENVECTORS. APPLICATIONS September 26, 207 EIGENVALUES AND EIGENVECTORS. APPLICATIONS RODICA D. COSTIN Contents 4. Eigenvalues and Eigenvectors 3 4.. Motivation 3 4.2. Diagonal matrices 3 4.3. Example: solving linear differential

More information

JORDAN NORMAL FORM. Contents Introduction 1 Jordan Normal Form 1 Conclusion 5 References 5

JORDAN NORMAL FORM. Contents Introduction 1 Jordan Normal Form 1 Conclusion 5 References 5 JORDAN NORMAL FORM KATAYUN KAMDIN Abstract. This paper outlines a proof of the Jordan Normal Form Theorem. First we show that a complex, finite dimensional vector space can be decomposed into a direct

More information

Outline. 1 Numerical Integration. 2 Numerical Differentiation. 3 Richardson Extrapolation

Outline. 1 Numerical Integration. 2 Numerical Differentiation. 3 Richardson Extrapolation Outline Numerical Integration Numerical Differentiation Numerical Integration Numerical Differentiation 3 Michael T. Heath Scientific Computing / 6 Main Ideas Quadrature based on polynomial interpolation:

More information

Mathematical Methods wk 1: Vectors

Mathematical Methods wk 1: Vectors Mathematical Methods wk : Vectors John Magorrian, magog@thphysoxacuk These are work-in-progress notes for the second-year course on mathematical methods The most up-to-date version is available from http://www-thphysphysicsoxacuk/people/johnmagorrian/mm

More information

Mathematical Methods wk 1: Vectors

Mathematical Methods wk 1: Vectors Mathematical Methods wk : Vectors John Magorrian, magog@thphysoxacuk These are work-in-progress notes for the second-year course on mathematical methods The most up-to-date version is available from http://www-thphysphysicsoxacuk/people/johnmagorrian/mm

More information

ELEMENTARY LINEAR ALGEBRA

ELEMENTARY LINEAR ALGEBRA ELEMENTARY LINEAR ALGEBRA K R MATTHEWS DEPARTMENT OF MATHEMATICS UNIVERSITY OF QUEENSLAND First Printing, 99 Chapter LINEAR EQUATIONS Introduction to linear equations A linear equation in n unknowns x,

More information

CSL361 Problem set 4: Basic linear algebra

CSL361 Problem set 4: Basic linear algebra CSL361 Problem set 4: Basic linear algebra February 21, 2017 [Note:] If the numerical matrix computations turn out to be tedious, you may use the function rref in Matlab. 1 Row-reduced echelon matrices

More information

MATH 423 Linear Algebra II Lecture 3: Subspaces of vector spaces. Review of complex numbers. Vector space over a field.

MATH 423 Linear Algebra II Lecture 3: Subspaces of vector spaces. Review of complex numbers. Vector space over a field. MATH 423 Linear Algebra II Lecture 3: Subspaces of vector spaces. Review of complex numbers. Vector space over a field. Vector space A vector space is a set V equipped with two operations, addition V V

More information

Overlapping Schwarz preconditioners for Fekete spectral elements

Overlapping Schwarz preconditioners for Fekete spectral elements Overlapping Schwarz preconditioners for Fekete spectral elements R. Pasquetti 1, L. F. Pavarino 2, F. Rapetti 1, and E. Zampieri 2 1 Laboratoire J.-A. Dieudonné, CNRS & Université de Nice et Sophia-Antipolis,

More information

Partial Differential Equations and the Finite Element Method

Partial Differential Equations and the Finite Element Method Partial Differential Equations and the Finite Element Method Pavel Solin The University of Texas at El Paso Academy of Sciences ofthe Czech Republic iwiley- INTERSCIENCE A JOHN WILEY & SONS, INC, PUBLICATION

More information

A Polynomial Chaos Approach to Robust Multiobjective Optimization

A Polynomial Chaos Approach to Robust Multiobjective Optimization A Polynomial Chaos Approach to Robust Multiobjective Optimization Silvia Poles 1, Alberto Lovison 2 1 EnginSoft S.p.A., Optimization Consulting Via Giambellino, 7 35129 Padova, Italy s.poles@enginsoft.it

More information

INTRODUCTION TO LIE ALGEBRAS. LECTURE 2.

INTRODUCTION TO LIE ALGEBRAS. LECTURE 2. INTRODUCTION TO LIE ALGEBRAS. LECTURE 2. 2. More examples. Ideals. Direct products. 2.1. More examples. 2.1.1. Let k = R, L = R 3. Define [x, y] = x y the cross-product. Recall that the latter is defined

More information

The Closed Form Reproducing Polynomial Particle Shape Functions for Meshfree Particle Methods

The Closed Form Reproducing Polynomial Particle Shape Functions for Meshfree Particle Methods The Closed Form Reproducing Polynomial Particle Shape Functions for Meshfree Particle Methods by Hae-Soo Oh Department of Mathematics, University of North Carolina at Charlotte, Charlotte, NC 28223 June

More information

Problems in Linear Algebra and Representation Theory

Problems in Linear Algebra and Representation Theory Problems in Linear Algebra and Representation Theory (Most of these were provided by Victor Ginzburg) The problems appearing below have varying level of difficulty. They are not listed in any specific

More information

A strongly polynomial algorithm for linear systems having a binary solution

A strongly polynomial algorithm for linear systems having a binary solution A strongly polynomial algorithm for linear systems having a binary solution Sergei Chubanov Institute of Information Systems at the University of Siegen, Germany e-mail: sergei.chubanov@uni-siegen.de 7th

More information

Contents. I Basic Methods 13

Contents. I Basic Methods 13 Preface xiii 1 Introduction 1 I Basic Methods 13 2 Convergent and Divergent Series 15 2.1 Introduction... 15 2.1.1 Power series: First steps... 15 2.1.2 Further practical aspects... 17 2.2 Differential

More information

Simple Examples on Rectangular Domains

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

More information

Notes on basis changes and matrix diagonalization

Notes on basis changes and matrix diagonalization Notes on basis changes and matrix diagonalization Howard E Haber Santa Cruz Institute for Particle Physics, University of California, Santa Cruz, CA 95064 April 17, 2017 1 Coordinates of vectors and matrix

More information

Math Linear Algebra II. 1. Inner Products and Norms

Math Linear Algebra II. 1. Inner Products and Norms Math 342 - Linear Algebra II Notes 1. Inner Products and Norms One knows from a basic introduction to vectors in R n Math 254 at OSU) that the length of a vector x = x 1 x 2... x n ) T R n, denoted x,

More information

INTRODUCTION TO MULTIGRID METHODS

INTRODUCTION TO MULTIGRID METHODS INTRODUCTION TO MULTIGRID METHODS LONG CHEN 1. ALGEBRAIC EQUATION OF TWO POINT BOUNDARY VALUE PROBLEM We consider the discretization of Poisson equation in one dimension: (1) u = f, x (0, 1) u(0) = u(1)

More information

Def. A topological space X is disconnected if it admits a non-trivial splitting: (We ll abbreviate disjoint union of two subsets A and B meaning A B =

Def. A topological space X is disconnected if it admits a non-trivial splitting: (We ll abbreviate disjoint union of two subsets A and B meaning A B = CONNECTEDNESS-Notes Def. A topological space X is disconnected if it admits a non-trivial splitting: X = A B, A B =, A, B open in X, and non-empty. (We ll abbreviate disjoint union of two subsets A and

More information

4.7 The Levi-Civita connection and parallel transport

4.7 The Levi-Civita connection and parallel transport Classnotes: Geometry & Control of Dynamical Systems, M. Kawski. April 21, 2009 138 4.7 The Levi-Civita connection and parallel transport In the earlier investigation, characterizing the shortest curves

More information

Applied Numerical Analysis (AE2220-I) R. Klees and R.P. Dwight

Applied Numerical Analysis (AE2220-I) R. Klees and R.P. Dwight Applied Numerical Analysis (AE0-I) R. Klees and R.P. Dwight February 018 Contents 1 Preliminaries: Motivation, Computer arithmetic, Taylor series 1 1.1 Numerical Analysis Motivation..........................

More information

(0, 0), (1, ), (2, ), (3, ), (4, ), (5, ), (6, ).

(0, 0), (1, ), (2, ), (3, ), (4, ), (5, ), (6, ). 1 Interpolation: The method of constructing new data points within the range of a finite set of known data points That is if (x i, y i ), i = 1, N are known, with y i the dependent variable and x i [x

More information

Construction of `Wachspress type' rational basis functions over rectangles

Construction of `Wachspress type' rational basis functions over rectangles Proc. Indian Acad. Sci. (Math. Sci.), Vol. 110, No. 1, February 2000, pp. 69±77. # Printed in India Construction of `Wachspress type' rational basis functions over rectangles P L POWAR and S S RANA Department

More information

We consider the problem of finding a polynomial that interpolates a given set of values:

We consider the problem of finding a polynomial that interpolates a given set of values: Chapter 5 Interpolation 5. Polynomial Interpolation We consider the problem of finding a polynomial that interpolates a given set of values: x x 0 x... x n y y 0 y... y n where the x i are all distinct.

More information

Triangular Plate Displacement Elements

Triangular Plate Displacement Elements Triangular Plate Displacement Elements Chapter : TRIANGULAR PLATE DISPLACEMENT ELEMENTS TABLE OF CONTENTS Page. Introduction...................... Triangular Element Properties................ Triangle

More information

Polynomials. p n (x) = a n x n + a n 1 x n 1 + a 1 x + a 0, where

Polynomials. p n (x) = a n x n + a n 1 x n 1 + a 1 x + a 0, where Polynomials Polynomials Evaluation of polynomials involve only arithmetic operations, which can be done on today s digital computers. We consider polynomials with real coefficients and real variable. p

More information

MULTIVARIATE BIRKHOFF-LAGRANGE INTERPOLATION SCHEMES AND CARTESIAN SETS OF NODES. 1. Introduction

MULTIVARIATE BIRKHOFF-LAGRANGE INTERPOLATION SCHEMES AND CARTESIAN SETS OF NODES. 1. Introduction Acta Math. Univ. Comenianae Vol. LXXIII, 2(2004), pp. 217 221 217 MULTIVARIATE BIRKHOFF-LAGRANGE INTERPOLATION SCHEMES AND CARTESIAN SETS OF NODES N. CRAINIC Abstract. In this paper we study the relevance

More information

Linear Algebra (part 1) : Vector Spaces (by Evan Dummit, 2017, v. 1.07) 1.1 The Formal Denition of a Vector Space

Linear Algebra (part 1) : Vector Spaces (by Evan Dummit, 2017, v. 1.07) 1.1 The Formal Denition of a Vector Space Linear Algebra (part 1) : Vector Spaces (by Evan Dummit, 2017, v. 1.07) Contents 1 Vector Spaces 1 1.1 The Formal Denition of a Vector Space.................................. 1 1.2 Subspaces...................................................

More information

446 CHAP. 8 NUMERICAL OPTIMIZATION. Newton's Search for a Minimum of f(x,y) Newton s Method

446 CHAP. 8 NUMERICAL OPTIMIZATION. Newton's Search for a Minimum of f(x,y) Newton s Method 446 CHAP. 8 NUMERICAL OPTIMIZATION Newton's Search for a Minimum of f(xy) Newton s Method The quadratic approximation method of Section 8.1 generated a sequence of seconddegree Lagrange polynomials. It

More information

Construction of Smooth Fractal Surfaces Using Hermite Fractal Interpolation Functions. P. Bouboulis, L. Dalla and M. Kostaki-Kosta

Construction of Smooth Fractal Surfaces Using Hermite Fractal Interpolation Functions. P. Bouboulis, L. Dalla and M. Kostaki-Kosta BULLETIN OF THE GREEK MATHEMATICAL SOCIETY Volume 54 27 (79 95) Construction of Smooth Fractal Surfaces Using Hermite Fractal Interpolation Functions P. Bouboulis L. Dalla and M. Kostaki-Kosta Received

More information

Application of modified Leja sequences to polynomial interpolation

Application of modified Leja sequences to polynomial interpolation Special Issue for the years of the Padua points, Volume 8 5 Pages 66 74 Application of modified Leja sequences to polynomial interpolation L. P. Bos a M. Caliari a Abstract We discuss several applications

More information

MATH 8253 ALGEBRAIC GEOMETRY WEEK 12

MATH 8253 ALGEBRAIC GEOMETRY WEEK 12 MATH 8253 ALGEBRAIC GEOMETRY WEEK 2 CİHAN BAHRAN 3.2.. Let Y be a Noetherian scheme. Show that any Y -scheme X of finite type is Noetherian. Moreover, if Y is of finite dimension, then so is X. Write f

More information

MET Workshop: Exercises

MET Workshop: Exercises MET Workshop: Exercises Alex Blumenthal and Anthony Quas May 7, 206 Notation. R d is endowed with the standard inner product (, ) and Euclidean norm. M d d (R) denotes the space of n n real matrices. When

More information

Lecture 7: Positive Semidefinite Matrices

Lecture 7: Positive Semidefinite Matrices Lecture 7: Positive Semidefinite Matrices Rajat Mittal IIT Kanpur The main aim of this lecture note is to prepare your background for semidefinite programming. We have already seen some linear algebra.

More information

8 A pseudo-spectral solution to the Stokes Problem

8 A pseudo-spectral solution to the Stokes Problem 8 A pseudo-spectral solution to the Stokes Problem 8.1 The Method 8.1.1 Generalities We are interested in setting up a pseudo-spectral method for the following Stokes Problem u σu p = f in Ω u = 0 in Ω,

More information

INTRODUCTION TO FINITE ELEMENT METHODS

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

More information

EIGENVALUES AND EIGENVECTORS 3

EIGENVALUES AND EIGENVECTORS 3 EIGENVALUES AND EIGENVECTORS 3 1. Motivation 1.1. Diagonal matrices. Perhaps the simplest type of linear transformations are those whose matrix is diagonal (in some basis). Consider for example the matrices

More information

1 Directional Derivatives and Differentiability

1 Directional Derivatives and Differentiability Wednesday, January 18, 2012 1 Directional Derivatives and Differentiability Let E R N, let f : E R and let x 0 E. Given a direction v R N, let L be the line through x 0 in the direction v, that is, L :=

More information

BIVARIATE LAGRANGE INTERPOLATION AT THE PADUA POINTS: THE IDEAL THEORY APPROACH

BIVARIATE LAGRANGE INTERPOLATION AT THE PADUA POINTS: THE IDEAL THEORY APPROACH BIVARIATE LAGRANGE INTERPOLATION AT THE PADUA POINTS: THE IDEAL THEORY APPROACH LEN BOS, STEFANO DE MARCHI, MARCO VIANELLO, AND YUAN XU Abstract The Padua points are a family of points on the square [,

More information

MA2501 Numerical Methods Spring 2015

MA2501 Numerical Methods Spring 2015 Norwegian University of Science and Technology Department of Mathematics MA5 Numerical Methods Spring 5 Solutions to exercise set 9 Find approximate values of the following integrals using the adaptive

More information

4.6. Linear Operators on Hilbert Spaces

4.6. Linear Operators on Hilbert Spaces 4.6. Linear Operators on Hilbert Spaces 1 4.6. Linear Operators on Hilbert Spaces Note. This section explores a number of different kinds of bounded linear transformations (or, equivalently, operators

More information