Building a finite element program in MATLAB Linear elements in 1d and 2d

Size: px
Start display at page:

Download "Building a finite element program in MATLAB Linear elements in 1d and 2d"

Transcription

1 Building a finite element program in MATLAB Linear elements in 1d and 2d D. Peschka TU Berlin Supplemental material for the course Numerische Mathematik 2 für Ingenieure at the Technical University Berlin, WS 2013/2014 D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 1 / 32

2 Content 1 Introduction 2 Decomposition and elements 3 Reference element 4 Basis and shape functions 5 The global matrix D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 2 / 32

3 Plan 1 Introduction 2 Decomposition and elements 3 Reference element 4 Basis and shape functions 5 The global matrix

4 Introduction Let V a Hilbert space, e.g. H0 1 (Ω). For a bilinear form a : V V R and linear form f : V R solve the following problem: Definition (variational problem) Find u V such that for all v V. a(u, v) = f (v), Example (variational problem for c 0) a(u, v) = f (v) = Ω Ω u(x) v(x) + c u(x)v(x) dx, f (x)v(x) dx, is the weak form of the elliptic problem u + cu = f. D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 3 / 32

5 Introduction By choosing a finite dimensional subspace V h V we introduce the Galerkin approximation: Definition (Galerkin approximation) Find u h V h such that for all v h V h. a(u h, v h ) = f (v h ) We have a set of functions w i which form a basis of V h. Then every element of V h (and in particular the solution) can be written u(x) = dim V h i=1 α i w i (x) D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 4 / 32

6 Introduction Then we may rewrite the Galerkin approximation: Definition (Galerkin approximation) Find α i R for i = 1... dim V h such that dim V h i=1 a(w i, w j )α i = f (w j ) for all j = 1... dim V h. Equivalently we may write where A ij = a(w j, w i ), f i = f (w i ). Aα = f D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 5 / 32

7 Introduction Motivation: The finite element method (FEM) is a particular method to systematically generate the finite-dimensional subspace V h of V and generate the Galerkin matrix A. Therefore the method generates a decomposition of Ω = k Ω k, defines basis functions w i which for each i are only non-zero on a few Ω k, maps these to a reference domain/shape functions. These basis function are usually piecewise polynomials and globally continuous. The resulting matrix A is sparse. Here we are going to construct a finite-dimensional subspace of the Hilbert space H 1 (Ω) or H 1 0 (Ω). Many concepts shown here are still valid for H r (Ω) and r > 1. D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 6 / 32

8 Introduction Finite elements Loosely speaking Lagrange finite elements consist of geometric objects (triangles, quadrilaterals, tetrahedrons,...), the set of piecewise polynomials P on each geometric object, the set of unknowns, i.e. values of basis functions at certain points p i (on vertices, edges, elements,...) i = 1... dim V h. The construction of FE basis functions w i P is such that the relation between the set of polynomials and the unknowns is and this condition gives unique w i s. w i (p j ) = δ ij D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 7 / 32

9 Plan 1 Introduction 2 Decomposition and elements 3 Reference element 4 Basis and shape functions 5 The global matrix

10 Decomposition and elements: 1d definition Definition (admissible decomposition 1d) For domain Ω R the decomposition Ω = nelement k=1 is called admissible, if Ω k Ω l is either the full element only for k = l, a common vertex, or otherwise empty. Ω k D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 8 / 32

11 Decomposition and elements: 2d definition Definition (admissible triangulation/decomposition 2d) For domain Ω R 2 with polygonal boundary the decomposition Ω = nelement k=1 is called admissible triangulation, if Ω k Ω l is either the full triangle element only for k = l, a common vertex, a (full) common edge, or otherwise empty. Ω k D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 9 / 32

12 Decomposition and elements: 1d and 2d Question: How do we represent a triangulation in practice? Answer 1d: x, e2p, npoint, nelement where npoint is the number of points/vertices, nelement is the number of elements (intervals), x R npoint is the collection of vertices of triangles, e2p R nelement 2 the element-to-point (or vertex) map. Answer 2d: x, e2p, npoint, nelement where npoint is the number of points/vertices, nelement is the number of elements (triangles), x,y R npoint is the collection of vertices of triangles, e2p R nelement 3 the element-to-point (or vertex) map. D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 10 / 32

13 Decomposition and elements: Remark Some programs might provide additional information, e.g. in 2d number of edges, identification of boundary points, identification of boundary edges, neighboring elements, special functions operating on triangulation, e.g. see DelaunayTri class in MATLAB. Despite from being very useful, most of these things can be derived from x,y,e2p. D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 11 / 32

14 Decomposition and elements: 1d example points 1 2 x 0 x 1 3 x 2 4 x 3 5 x 4 elements npoint=5, nelement=4, x=[0 1/4 2/4 3/4 1], e2p(1:4,1)=1:4, e2p(1:4,2)=2:5, Ω k = [x k 1, x k ] for k = 1..nelement. D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 12 / 32

15 Decomposition and elements: 1d MATLAB code 1 npoint = 5; % # points in decomposition 2 nelement = npoint - 1; % # elements / intervals 3 4 x = linspace (0,1, npoint ); % create vertices 5 6 e2p (1: nelement,1) = 1: npoint -1; % create e2p, part 1 7 e2p (1: nelement,2) = 2: npoint ; % create e2p, part plot (x,0*x,'b-o',' MarkerFaceColor ','r') % draw decomposition D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 13 / 32

16 Decomposition and elements: 2d example npoint=16, nelement=18, x=[ ]/3, y=[ ]/3, e2p R Ω k = conv{x e2p(k,1), x e2p(k,2), x e2p(k,3) }. D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 14 / 32

17 Decomposition and elements: 2d example Where the convex-hull of points is defined { } 3 3 conv(x 1, x 2, x 3 ) := x R 2 : x = ξ α x α ; ξ α 0; ξ α = 1, α=1 α=1 or alternatively for a point as x = x 1 x 2 x 3 y y 1 y 2 y 3 for the barycentric coordinates ξ 1, ξ 2, ξ 3 0. ξ 1 ξ 2, ξ 3 Note: The generalization to 3d gives a tetrahedron, the restriction to 1d gives an interval. D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 15 / 32

18 Decomposition and elements: 2d example e2p = D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 16 / 32

19 Decomposition and elements: 2d MATLAB code 1 n = 4; % parameter 2 [x,y]= meshgrid ( linspace (0,1,n )); % 2D array of vertices 3 x=x (:); y=y (:); % array -> vector 4 e2p = delaunay (x,y); % Delaunay triangulation 5 npoint = size (x,1); % # points 6 nelement = size (e2p,1); % # elements 7 8 % plot the decomposition 9 triplot (e2p,x,y,'o-','color ','b',' MarkerFaceColor ','r') D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 17 / 32

20 Plan 1 Introduction 2 Decomposition and elements 3 Reference element 4 Basis and shape functions 5 The global matrix

21 t Reference element: Definition 1d: Ω ref = (0, 1), p 1 = 0, p 2 = 1 2d: Ω ref = {(s, t) R 2 : s, t > 0; 0 < s < 1 t}, p 1 = (0, 0), p 2 = (1, 0), p 3 = (0, 1) s D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 18 / 32

22 Reference element: Map to element For each element F k we have a map F k : Ω ref Ω k which is affine linear so that the following identity holds F k (p m ) = x i for i=e2p(k,m) and x i is the ith vertex. The map is a linear polynomial, i.e., F k (p) = A k p + B k where (1d) A k, B k R or (2d) A k R 2 2, B k R 2. We have and (1d) and (2d) B k = x e2p(k,1) A k = x e2p(k,2) x e2p(k,1) R A k = ( x e2p(k,2) x e2p(k,1), x e2p(k,3) x e2p(k,1) ) R 2 2 D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 19 / 32

23 Reference element: Map to element Note: Note that F k = A k MATLAB code fragment to determine B k for a given k 1 B (1)= x(e2p (k,1)); % first component of B 2 B (2)= y(e2p (k,1)); % second component of B MATLAB code fragment to determine (A k ) 22 for a given k 1 A (2,2)= y(e2p (k,3)) -y(e2p (k,1)); % 22 component of A D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 20 / 32

24 Reference element Some extensions are useful: transformation F k using polynomial of higher degree e.g. isoparametric elements. 1 quadrilateral elements (2d), tetrahedrons (3d) 1 More complicated since F k depends on space and we need to introduce numerical integration techniques. D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 21 / 32

25 Plan 1 Introduction 2 Decomposition and elements 3 Reference element 4 Basis and shape functions 5 The global matrix

26 Basis and shape functions For a given decomposition/triangulation Ω k we define basis functions w i by w i (x j ) = δ ij, w i is piecewise polynomial (linear) on every Ω k, w i is continuous, so that w i are in the finite element space w i V h V. D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 22 / 32

27 Note: Red circles indicate the position of vertices. D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 23 / 32 Basis and shape functions: 1d With npoint=5 and V = H 1 (0, 1) we have the following w i : 1 w 5 w 4 w 3 w 2 w x x x x x For V = H 1 0 (0, 1) the (three) basis functions of V h are w 1 (x) = w 2 (x), w 2 (x) = w 3 (x), w 3 (x) = w 4 (x).

28 Basis and shape functions: 2d With npoint=16, Ω = (0, 1) 2 and V = H 1 (Ω) we have 16 basis functions w i. For example i = 1, i = 6, i = 15: D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 24 /

29 Basis and shape functions: 2d With npoint=16, Ω = (0, 1) 2 and V = H 1 (Ω) we have 16 basis functions w i. For example i = 1, i = 6, i = 15: D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 24 / 32

30 Basis and shape functions: 2d With npoint=16, Ω = (0, 1) 2 and V = H 1 (Ω) we have 16 basis functions w i. For example i = 1, i = 6, i = 15: D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 24 /

31 Basis and shape functions: basis shape The basis functions are maps w i : Ω R for i = 1... dim V h. The shape functions are maps φ n : Ω ref R for n = 1... nphi. Definition (shape functions) Using the map F k we have the identity w i ( Fk (p) ) = φ n (p) for i=e2p(k,n) for every p Ω ref, k = 1... nelement, n = 1... nphi. This is the key-property ensuring continuity of w i and thereby w i V h H 1 (Ω). Beyond linear Lagrange elements we need to extend e2p(1:nelement,1:nphi), where each n = 1... nphi is identified with a point p n at 1d) i) a vertex, ii) an element 2d) i) a vertex, ii) an edge, iii) an element, 3d) i) a vertex, ii) an edge, iii) a face, iv) an element. D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 25 / 32

32 Basis and shape functions: basis shape Example Linear intervals in 1d: nphi=2, Linear triangles in 2d: nphi=3, Linear tetrahedrons in 3d: nphi=4, Quadratic intervals in 1d: nphi=3, Quadratic triangles in 2d: nphi=6, Quadratic tetrahedrons in 3d: nphi=10. D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 26 / 32

33 Basis and shape functions: Shape functions Example (1d linear interval, nphi=2) φ 1 (s) = 1 s, φ 2 (s) = s p 1 = 0, p 2 = 1. Example (2d linear triangle, nphi=3) φ 1 (s, t) = 1 s t, φ 2 (s, t) = s, φ 3 (s, t) = t, p 1 = (0, 0), p 2 = (1, 0), p 3 = (0, 1), Example (2d quadratic triangle, nphi=6) φ n (s, t) = a n 1 + a n 2 s + a n 3 t + a n 4 st + a n 5 s 2 + a n 6 t 2 where the 36 coefficients are determined by the condition φ n (p m ) = δ nm p 1 = (0, 0), p 2 = (1, 0), p 3 = (0, 1), p 4 = ( 1 2, 0), p 5 = ( 1 2, 1 2 ), p 6 = (0, 1 2 ). D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 27 / 32

34 Basis and shape functions: Matrices for shape functions In principle we want to compute integrals such as M = Ω w i (x)w j (x) dω = nelement k=1 Ω k w i (x)w j (x) dω Since we have the identity w i (F k (p)) = φ n (p) we can compute this integral over Ω k = F k (Ω ref ) using integration by substitution f (x) dx = f ( F k (p) ) det( F k ) dp F k (Ω ref ) Ω ref and get w i (x)w j (x) dω = φ m (p)φ n (p) det(a k ) dp Ω k Ω ref with the identity i = e2p(k,m), j = e2p(k,n). A similar equation holds for S = Ω w i(x)w j(x) dx. D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 28 / 32

35 Plan 1 Introduction 2 Decomposition and elements 3 Reference element 4 Basis and shape functions 5 The global matrix

36 The global matrix How to build the matrix M in 1d: nelement M ij = φ m (p)φ n (p) det(a k ) dp Ω ref k=1 where i = e2p(k,m), j = e2p(k,n). 1 %% prepare fem stuff 2 p = 7; 3 nphi = 2; 4 x = linspace (0,1,2ˆp+1); 5 [ nelement, npoint, e2p ] = generateelements (x); 6 %% build matrices 7 ii = zeros (nelement,nphi ˆ2); % sparse i- index 8 jj = zeros (nelement,nphi ˆ2); % sparse j- index 9 mm = zeros ( nelement, nphi ˆ2); % entry of Galerkin matrix 10 %% build global from local 11 for k =1: nelement % loop over elements 12 [edet, dfinv ] = generatetransformation (k,e2p,x); % compute map 13 mloc = localmass ( edet ); % element mass matrix 14 % compute i,j indices of the global matrix 15 ii( k,: ) = [e2p (k,1) e2p (k,2) e2p (k,1) e2p (k,2)]; % local -to - global 16 jj( k,: ) = [e2p (k,1) e2p (k,1) e2p (k,2) e2p (k,2)]; % local -to - global 17 % compute a(i,j) values of the global matrix 18 mm( k,: ) = mloc (:); 19 end 20 % create sparse matrices 21 M= sparse (ii (:), jj (:), mm (:)); D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 29 / 32

37 The global matrix MATLAB code generateelements.m 1 % Generate infrastructure for FEM. 2 function [ nelement, npoint, e2p ] = generateelements (x) 3 npoint = length (x); 4 nelement = npoint -1; 5 e2p = zeros ( nelement,2); 6 e2p (1: nelement,1)=1: npoint -1; 7 e2p (1: nelement,2)=2: npoint ; MATLAT code generatetransformation.m 1 % Compute the determinant of the Jacobian on every triangle. 2 function [edet, dfinv ]= generatetransformation (k,e2p,x) 3 edet = x(e2p (k,2)) -x(e2p (k,1)); 4 dfinv = 1/ edet ; MATLAB code localmass.m 1 % Local mass matrix M = \ int phi_i phi_j dx 2 function m= localmass ( det ) 3 m=det *[1/3 1/6;1/6 1/3]; MATLAB code localstiff.m 1 % Local stiffness matrix S = \ int phi '_i * phi '_j dx 2 function S=localstiff (det, dfinv ) 3 ndim = 1; 4 nphi = 2; 5 6 gradphiloc (1,1) = -1; 7 gradphiloc (2,1) = +1; 8 9 dphi (1: nphi,1: ndim ) = gradphiloc (1: nphi,1: ndim )* dfinv (1: ndim,1: ndim ); 10 S=( dphi (:,1)* dphi (:,1) ') * det ; D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 30 / 32

38 The global matrix When computing S we need partial derivatives of w i, which can be represented for instance by x w i (x, y) = x φ m (F 1 k (x, y)) where F k = A k p + B k = (x, y) with p = (s, t). Then x w i = φ m s y w i = φ m s s x + φ m t t x s y + φ m t t y so that using p = A 1 k ((x, y) B k ), we get ( ) ( ) ( ) x w w i = i x s = x t s φ m y w i y s y t t φ m so that w i w j = φ m A 1 k A k φ n. = (A 1 k ) φ m. D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 31 / 32

39 End D. Peschka (TU Berlin) FEM with MATLAB Num2 WS13/14 32 / 32

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1 Scientific Computing WS 2017/2018 Lecture 18 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 18 Slide 1 Lecture 18 Slide 2 Weak formulation of homogeneous Dirichlet problem Search u H0 1 (Ω) (here,

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

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

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of,

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of, 269 C, Vese Practice problems [1] Write the differential equation u + u = f(x, y), (x, y) Ω u = 1 (x, y) Ω 1 n + u = x (x, y) Ω 2, Ω = {(x, y) x 2 + y 2 < 1}, Ω 1 = {(x, y) x 2 + y 2 = 1, x 0}, Ω 2 = {(x,

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

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

Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials

Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials Platzhalter für Bild, Bild auf Titelfolie hinter das Logo einsetzen Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials Dr. Noemi Friedman Contents of the course Fundamentals

More information

Interpolation (Shape Functions)

Interpolation (Shape Functions) Mètodes Numèrics: A First Course on Finite Elements Interpolation (Shape Functions) Following: Curs d Elements Finits amb Aplicacions (J. Masdemont) http://hdl.handle.net/2099.3/36166 Dept. Matemàtiques

More information

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs Chapter Two: Numerical Methods for Elliptic PDEs Finite Difference Methods for Elliptic PDEs.. Finite difference scheme. We consider a simple example u := subject to Dirichlet boundary conditions ( ) u

More information

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

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

More information

Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials

Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials Platzhalter für Bild, Bild auf Titelfolie hinter das Logo einsetzen Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials Dr. Noemi Friedman Contents of the course Fundamentals

More information

Scientific Computing I

Scientific Computing I Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Neckel Winter 2013/2014 Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 1 Part I: Introduction to

More information

The Plane Stress Problem

The Plane Stress Problem The Plane Stress Problem Martin Kronbichler Applied Scientific Computing (Tillämpad beräkningsvetenskap) February 2, 2010 Martin Kronbichler (TDB) The Plane Stress Problem February 2, 2010 1 / 24 Outline

More information

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES)

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) RAYTCHO LAZAROV 1 Notations and Basic Functional Spaces Scalar function in R d, d 1 will be denoted by u,

More information

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

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

More information

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

TMA4220: Programming project - part 1

TMA4220: Programming project - part 1 TMA4220: Programming project - part 1 TMA4220 - Numerical solution of partial differential equations using the finite element method The programming project will be split into two parts. This is the first

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

A Hybrid Method for the Wave Equation. beilina

A Hybrid Method for the Wave Equation.   beilina A Hybrid Method for the Wave Equation http://www.math.unibas.ch/ beilina 1 The mathematical model The model problem is the wave equation 2 u t 2 = (a 2 u) + f, x Ω R 3, t > 0, (1) u(x, 0) = 0, x Ω, (2)

More information

1 Discretizing BVP with Finite Element Methods.

1 Discretizing BVP with Finite Element Methods. 1 Discretizing BVP with Finite Element Methods In this section, we will discuss a process for solving boundary value problems numerically, the Finite Element Method (FEM) We note that such method is a

More information

Higher-Order Compact Finite Element Method

Higher-Order Compact Finite Element Method Higher-Order Compact Finite Element Method Major Qualifying Project Advisor: Professor Marcus Sarkis Amorn Chokchaisiripakdee Worcester Polytechnic Institute Abstract The Finite Element Method (FEM) is

More information

Chapter 1 Foundations of Elliptic Boundary Value Problems 1.1 Euler equations of variational problems

Chapter 1 Foundations of Elliptic Boundary Value Problems 1.1 Euler equations of variational problems Chapter 1 Foundations of Elliptic Boundary Value Problems 1.1 Euler equations of variational problems Elliptic boundary value problems often occur as the Euler equations of variational problems the latter

More information

PDE & FEM TERMINOLOGY. BASIC PRINCIPLES OF FEM.

PDE & FEM TERMINOLOGY. BASIC PRINCIPLES OF FEM. PDE & FEM TERMINOLOGY. BASIC PRINCIPLES OF FEM. Sergey Korotov Basque Center for Applied Mathematics / IKERBASQUE http://www.bcamath.org & http://www.ikerbasque.net 1 Introduction The analytical solution

More information

A very short introduction to the Finite Element Method

A very short introduction to the Finite Element Method A very short introduction to the Finite Element Method Till Mathis Wagner Technical University of Munich JASS 2004, St Petersburg May 4, 2004 1 Introduction This is a short introduction to the finite element

More information

Finite Elements. Colin Cotter. February 22, Colin Cotter FEM

Finite Elements. Colin Cotter. February 22, Colin Cotter FEM Finite Elements February 22, 2019 In the previous sections, we introduced the concept of finite element spaces, which contain certain functions defined on a domain. Finite element spaces are examples of

More information

A Finite Element Method for an Ill-Posed Problem. Martin-Luther-Universitat, Fachbereich Mathematik/Informatik,Postfach 8, D Halle, Abstract

A Finite Element Method for an Ill-Posed Problem. Martin-Luther-Universitat, Fachbereich Mathematik/Informatik,Postfach 8, D Halle, Abstract A Finite Element Method for an Ill-Posed Problem W. Lucht Martin-Luther-Universitat, Fachbereich Mathematik/Informatik,Postfach 8, D-699 Halle, Germany Abstract For an ill-posed problem which has its origin

More information

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V Part I: Introduction to Finite Element Methods Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Necel Winter 4/5 The Model Problem FEM Main Ingredients Wea Forms and Wea

More information

Hamburger Beiträge zur Angewandten Mathematik

Hamburger Beiträge zur Angewandten Mathematik Hamburger Beiträge zur Angewandten Mathematik Numerical analysis of a control and state constrained elliptic control problem with piecewise constant control approximations Klaus Deckelnick and Michael

More information

Numerical Solution I

Numerical Solution I Numerical Solution I Stationary Flow R. Kornhuber (FU Berlin) Summerschool Modelling of mass and energy transport in porous media with practical applications October 8-12, 2018 Schedule Classical Solutions

More information

Chapter 1: The Finite Element Method

Chapter 1: The Finite Element Method Chapter 1: The Finite Element Method Michael Hanke Read: Strang, p 428 436 A Model Problem Mathematical Models, Analysis and Simulation, Part Applications: u = fx), < x < 1 u) = u1) = D) axial deformation

More information

The Finite Line Integration Method (FLIM) - A Fast Variant of Finite Element Modelling

The Finite Line Integration Method (FLIM) - A Fast Variant of Finite Element Modelling www.oeaw.ac.at The Finite Line Integration Method (FLIM) - A Fast Variant of Finite Element Modelling J. Synka RICAM-Report 2007-27 www.ricam.oeaw.ac.at The Finite Line Integration Method (FLIM) - A Fast

More information

Analysis and Applications of Polygonal and Serendipity Finite Element Methods

Analysis and Applications of Polygonal and Serendipity Finite Element Methods Analysis and Applications of Polygonal and Serendipity Finite Element Methods Andrew Gillette Department of Mathematics University of California, San Diego http://ccom.ucsd.edu/ agillette/ Andrew Gillette

More information

OR MSc Maths Revision Course

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

More information

Middle East Technical University Department of Mechanical Engineering ME 413 Introduction to Finite Element Analysis. Chapter 2 Introduction to FEM

Middle East Technical University Department of Mechanical Engineering ME 413 Introduction to Finite Element Analysis. Chapter 2 Introduction to FEM Middle East Technical University Department of Mechanical Engineering ME 43 Introction to Finite Element Analysis Chapter 2 Introction to FEM These notes are prepared by Dr. Cüneyt Sert http://www.me.metu.e.tr/people/cuneyt

More information

Numerical Solution of Partial Differential Equations

Numerical Solution of Partial Differential Equations Numerical Solution of Partial Differential Equations Prof. Ralf Hiptmair, Prof. Christoph Schwab und Dr. H. Harbrecht V1.0: summer term 2004, V2.0: winter term 2005/2006 Draft version October 26, 2005

More information

Mixed Hybrid Finite Element Method: an introduction

Mixed Hybrid Finite Element Method: an introduction Mixed Hybrid Finite Element Method: an introduction First lecture Annamaria Mazzia Dipartimento di Metodi e Modelli Matematici per le Scienze Applicate Università di Padova mazzia@dmsa.unipd.it Scuola

More information

Convex Optimization and Modeling

Convex Optimization and Modeling Convex Optimization and Modeling Introduction and a quick repetition of analysis/linear algebra First lecture, 12.04.2010 Jun.-Prof. Matthias Hein Organization of the lecture Advanced course, 2+2 hours,

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

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

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

More information

Iterative Methods for Linear Systems

Iterative Methods for Linear Systems Iterative Methods for Linear Systems 1. Introduction: Direct solvers versus iterative solvers In many applications we have to solve a linear system Ax = b with A R n n and b R n given. If n is large the

More information

A non-standard Finite Element Method based on boundary integral operators

A non-standard Finite Element Method based on boundary integral operators A non-standard Finite Element Method based on boundary integral operators Clemens Hofreither Ulrich Langer Clemens Pechstein June 30, 2010 supported by Outline 1 Method description Motivation Variational

More information

Preconditioned space-time boundary element methods for the heat equation

Preconditioned space-time boundary element methods for the heat equation W I S S E N T E C H N I K L E I D E N S C H A F T Preconditioned space-time boundary element methods for the heat equation S. Dohr and O. Steinbach Institut für Numerische Mathematik Space-Time Methods

More information

PDEs, part 1: Introduction and elliptic PDEs

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

More information

A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations

A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations S. Hussain, F. Schieweck, S. Turek Abstract In this note, we extend our recent work for

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 via Barycentric Coordinates

Interpolation via Barycentric Coordinates Interpolation via Barycentric Coordinates Pierre Alliez Inria Some material from D. Anisimov Outline Barycenter Convexity Barycentric coordinates For Simplices For point sets Inverse distance (Shepard)

More information

Chapter 6 A posteriori error estimates for finite element approximations 6.1 Introduction

Chapter 6 A posteriori error estimates for finite element approximations 6.1 Introduction Chapter 6 A posteriori error estimates for finite element approximations 6.1 Introduction The a posteriori error estimation of finite element approximations of elliptic boundary value problems has reached

More information

Chapter 12. Partial di erential equations Di erential operators in R n. The gradient and Jacobian. Divergence and rotation

Chapter 12. Partial di erential equations Di erential operators in R n. The gradient and Jacobian. Divergence and rotation Chapter 12 Partial di erential equations 12.1 Di erential operators in R n The gradient and Jacobian We recall the definition of the gradient of a scalar function f : R n! R, as @f grad f = rf =,..., @f

More information

b i (x) u + c(x)u = f in Ω,

b i (x) u + c(x)u = f in Ω, SIAM J. NUMER. ANAL. Vol. 39, No. 6, pp. 1938 1953 c 2002 Society for Industrial and Applied Mathematics SUBOPTIMAL AND OPTIMAL CONVERGENCE IN MIXED FINITE ELEMENT METHODS ALAN DEMLOW Abstract. An elliptic

More information

1. Introduction. The Stokes problem seeks unknown functions u and p satisfying

1. Introduction. The Stokes problem seeks unknown functions u and p satisfying A DISCRETE DIVERGENCE FREE WEAK GALERKIN FINITE ELEMENT METHOD FOR THE STOKES EQUATIONS LIN MU, JUNPING WANG, AND XIU YE Abstract. A discrete divergence free weak Galerkin finite element method is developed

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Nonconformity and the Consistency Error First Strang Lemma Abstract Error Estimate

More information

Chapter 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

Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems

Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems Stan Tomov Innovative Computing Laboratory Computer Science Department The University of Tennessee Wednesday April 4,

More information

Matrix assembly by low rank tensor approximation

Matrix assembly by low rank tensor approximation Matrix assembly by low rank tensor approximation Felix Scholz 13.02.2017 References Angelos Mantzaflaris, Bert Juettler, Boris Khoromskij, and Ulrich Langer. Matrix generation in isogeometric analysis

More information

Karhunen-Loève Approximation of Random Fields Using Hierarchical Matrix Techniques

Karhunen-Loève Approximation of Random Fields Using Hierarchical Matrix Techniques Institut für Numerische Mathematik und Optimierung Karhunen-Loève Approximation of Random Fields Using Hierarchical Matrix Techniques Oliver Ernst Computational Methods with Applications Harrachov, CR,

More information

Applied/Numerical Analysis Qualifying Exam

Applied/Numerical Analysis Qualifying Exam Applied/Numerical Analysis Qualifying Exam August 9, 212 Cover Sheet Applied Analysis Part Policy on misprints: The qualifying exam committee tries to proofread exams as carefully as possible. Nevertheless,

More information

We simply compute: for v = x i e i, bilinearity of B implies that Q B (v) = B(v, v) is given by xi x j B(e i, e j ) =

We simply compute: for v = x i e i, bilinearity of B implies that Q B (v) = B(v, v) is given by xi x j B(e i, e j ) = Math 395. Quadratic spaces over R 1. Algebraic preliminaries Let V be a vector space over a field F. Recall that a quadratic form on V is a map Q : V F such that Q(cv) = c 2 Q(v) for all v V and c F, and

More information

arxiv: v1 [math.na] 13 Aug 2014

arxiv: v1 [math.na] 13 Aug 2014 THE NITSCHE XFEM-DG SPACE-TIME METHOD AND ITS IMPLEMENTATION IN THREE SPACE DIMENSIONS CHRISTOPH LEHRENFELD arxiv:1408.2941v1 [math.na] 13 Aug 2014 Abstract. In the recent paper [C. Lehrenfeld, A. Reusken,

More information

Boundary Value Problems and Iterative Methods for Linear Systems

Boundary Value Problems and Iterative Methods for Linear Systems Boundary Value Problems and Iterative Methods for Linear Systems 1. Equilibrium Problems 1.1. Abstract setting We want to find a displacement u V. Here V is a complete vector space with a norm v V. In

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University The Residual and Error of Finite Element Solutions Mixed BVP of Poisson Equation

More information

On angle conditions in the finite element method. Institute of Mathematics, Academy of Sciences Prague, Czech Republic

On angle conditions in the finite element method. Institute of Mathematics, Academy of Sciences Prague, Czech Republic On angle conditions in the finite element method Michal Křížek Institute of Mathematics, Academy of Sciences Prague, Czech Republic Joint work with Jan Brandts (University of Amsterdam), Antti Hannukainen

More information

Solution of Non-Homogeneous Dirichlet Problems with FEM

Solution of Non-Homogeneous Dirichlet Problems with FEM Master Thesis Solution of Non-Homogeneous Dirichlet Problems with FEM Francesco Züger Institut für Mathematik Written under the supervision of Prof. Dr. Stefan Sauter and Dr. Alexander Veit August 27,

More information

Again we return to a row of 1 s! Furthermore, all the entries are positive integers.

Again we return to a row of 1 s! Furthermore, all the entries are positive integers. Lecture Notes Introduction to Cluster Algebra Ivan C.H. Ip Updated: April 4, 207 Examples. Conway-Coxeter frieze pattern Frieze is the wide central section part of an entablature, often seen in Greek temples,

More information

Supraconvergence of a Non-Uniform Discretisation for an Elliptic Third-Kind Boundary-Value Problem with Mixed Derivatives

Supraconvergence of a Non-Uniform Discretisation for an Elliptic Third-Kind Boundary-Value Problem with Mixed Derivatives Supraconvergence of a Non-Uniform Discretisation for an Elliptic Third-Kind Boundary-Value Problem with Mixed Derivatives Etienne Emmrich Technische Universität Berlin, Institut für Mathematik, Straße

More information

Finite Element Methods with Linear B-Splines

Finite Element Methods with Linear B-Splines Finite Element Methods with Linear B-Splines K. Höllig, J. Hörner and M. Pfeil Universität Stuttgart Institut für Mathematische Methoden in den Ingenieurwissenschaften, Numerik und geometrische Modellierung

More information

Notes on Cellwise Data Interpolation for Visualization Xavier Tricoche

Notes on Cellwise Data Interpolation for Visualization Xavier Tricoche Notes on Cellwise Data Interpolation for Visualization Xavier Tricoche urdue University While the data (computed or measured) used in visualization is only available in discrete form, it typically corresponds

More information

Juan Vicente Gutiérrez Santacreu Rafael Rodríguez Galván. Departamento de Matemática Aplicada I Universidad de Sevilla

Juan Vicente Gutiérrez Santacreu Rafael Rodríguez Galván. Departamento de Matemática Aplicada I Universidad de Sevilla Doc-Course: Partial Differential Equations: Analysis, Numerics and Control Research Unit 3: Numerical Methods for PDEs Part I: Finite Element Method: Elliptic and Parabolic Equations Juan Vicente Gutiérrez

More information

AMS 147 Computational Methods and Applications Lecture 17 Copyright by Hongyun Wang, UCSC

AMS 147 Computational Methods and Applications Lecture 17 Copyright by Hongyun Wang, UCSC Lecture 17 Copyright by Hongyun Wang, UCSC Recap: Solving linear system A x = b Suppose we are given the decomposition, A = L U. We solve (LU) x = b in 2 steps: *) Solve L y = b using the forward substitution

More information

Lecture Notes: African Institute of Mathematics Senegal, January Topic Title: A short introduction to numerical methods for elliptic PDEs

Lecture Notes: African Institute of Mathematics Senegal, January Topic Title: A short introduction to numerical methods for elliptic PDEs Lecture Notes: African Institute of Mathematics Senegal, January 26 opic itle: A short introduction to numerical methods for elliptic PDEs Authors and Lecturers: Gerard Awanou (University of Illinois-Chicago)

More information

High order, finite volume method, flux conservation, finite element method

High order, finite volume method, flux conservation, finite element method FLUX-CONSERVING FINITE ELEMENT METHODS SHANGYOU ZHANG, ZHIMIN ZHANG, AND QINGSONG ZOU Abstract. We analyze the flux conservation property of the finite element method. It is shown that the finite element

More information

11. Periodicity of Klein polyhedra (28 June 2011) Algebraic irrationalities and periodicity of sails. Let A GL(n + 1, R) be an operator all of

11. Periodicity of Klein polyhedra (28 June 2011) Algebraic irrationalities and periodicity of sails. Let A GL(n + 1, R) be an operator all of 11. Periodicity of Klein polyhedra (28 June 2011) 11.1. lgebraic irrationalities and periodicity of sails. Let GL(n + 1, R) be an operator all of whose eigenvalues are real and distinct. Let us take the

More information

PREPRINT 2010:23. A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO

PREPRINT 2010:23. A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO PREPRINT 2010:23 A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO Department of Mathematical Sciences Division of Mathematics CHALMERS UNIVERSITY OF TECHNOLOGY UNIVERSITY OF GOTHENBURG

More information

1. Let a(x) > 0, and assume that u and u h are the solutions of the Dirichlet problem:

1. Let a(x) > 0, and assume that u and u h are the solutions of the Dirichlet problem: Mathematics Chalmers & GU TMA37/MMG800: Partial Differential Equations, 011 08 4; kl 8.30-13.30. Telephone: Ida Säfström: 0703-088304 Calculators, formula notes and other subject related material are not

More information

A posteriori error estimation for elliptic problems

A posteriori error estimation for elliptic problems A posteriori error estimation for elliptic problems Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in

More information

On an Approximation Result for Piecewise Polynomial Functions. O. Karakashian

On an Approximation Result for Piecewise Polynomial Functions. O. Karakashian BULLETIN OF THE GREE MATHEMATICAL SOCIETY Volume 57, 010 (1 7) On an Approximation Result for Piecewise Polynomial Functions O. arakashian Abstract We provide a new approach for proving approximation results

More information

An Iterative Substructuring Method for Mortar Nonconforming Discretization of a Fourth-Order Elliptic Problem in two dimensions

An Iterative Substructuring Method for Mortar Nonconforming Discretization of a Fourth-Order Elliptic Problem in two dimensions An Iterative Substructuring Method for Mortar Nonconforming Discretization of a Fourth-Order Elliptic Problem in two dimensions Leszek Marcinkowski Department of Mathematics, Warsaw University, Banacha

More information

(f P Ω hf) vdx = 0 for all v V h, if and only if Ω (f P hf) φ i dx = 0, for i = 0, 1,..., n, where {φ i } V h is set of hat functions.

(f P Ω hf) vdx = 0 for all v V h, if and only if Ω (f P hf) φ i dx = 0, for i = 0, 1,..., n, where {φ i } V h is set of hat functions. Answer ALL FOUR Questions Question 1 Let I = [, 2] and f(x) = (x 1) 3 for x I. (a) Let V h be the continous space of linear piecewise function P 1 (I) on I. Write a MATLAB code to compute the L 2 -projection

More information

Math 660-Lecture 15: Finite element spaces (I)

Math 660-Lecture 15: Finite element spaces (I) Math 660-Lecture 15: Finite element spaces (I) (Chapter 3, 4.2, 4.3) Before we introduce the concrete spaces, let s first of all introduce the following important lemma. Theorem 1. Let V h consists of

More information

HIGHER-ORDER THEORIES

HIGHER-ORDER THEORIES HIGHER-ORDER THEORIES THIRD-ORDER SHEAR DEFORMATION PLATE THEORY LAYERWISE LAMINATE THEORY J.N. Reddy 1 Third-Order Shear Deformation Plate Theory Assumed Displacement Field µ u(x y z t) u 0 (x y t) +

More information

ASYMPTOTICALLY EXACT A POSTERIORI ESTIMATORS FOR THE POINTWISE GRADIENT ERROR ON EACH ELEMENT IN IRREGULAR MESHES. PART II: THE PIECEWISE LINEAR CASE

ASYMPTOTICALLY EXACT A POSTERIORI ESTIMATORS FOR THE POINTWISE GRADIENT ERROR ON EACH ELEMENT IN IRREGULAR MESHES. PART II: THE PIECEWISE LINEAR CASE MATEMATICS OF COMPUTATION Volume 73, Number 246, Pages 517 523 S 0025-5718(0301570-9 Article electronically published on June 17, 2003 ASYMPTOTICALLY EXACT A POSTERIORI ESTIMATORS FOR TE POINTWISE GRADIENT

More information

pyoptfem Documentation

pyoptfem Documentation pyoptfem Documentation Release V0.0.6 F. Cuvelier November 09, 2013 CONTENTS 1 Presentation 3 1.1 Classical assembly algorithm (base version).............................. 6 1.2 Sparse matrix requirement........................................

More information

Chapter 7. Canonical Forms. 7.1 Eigenvalues and Eigenvectors

Chapter 7. Canonical Forms. 7.1 Eigenvalues and Eigenvectors Chapter 7 Canonical Forms 7.1 Eigenvalues and Eigenvectors Definition 7.1.1. Let V be a vector space over the field F and let T be a linear operator on V. An eigenvalue of T is a scalar λ F such that there

More information

A Relationship Between Minimum Bending Energy and Degree Elevation for Bézier Curves

A Relationship Between Minimum Bending Energy and Degree Elevation for Bézier Curves A Relationship Between Minimum Bending Energy and Degree Elevation for Bézier Curves David Eberly, Geometric Tools, Redmond WA 9852 https://www.geometrictools.com/ This work is licensed under the Creative

More information

On the computation of Hermite-Humbert constants for real quadratic number fields

On the computation of Hermite-Humbert constants for real quadratic number fields Journal de Théorie des Nombres de Bordeaux 00 XXXX 000 000 On the computation of Hermite-Humbert constants for real quadratic number fields par Marcus WAGNER et Michael E POHST Abstract We present algorithms

More information

An A Posteriori Error Estimate for Discontinuous Galerkin Methods

An A Posteriori Error Estimate for Discontinuous Galerkin Methods An A Posteriori Error Estimate for Discontinuous Galerkin Methods Mats G Larson mgl@math.chalmers.se Chalmers Finite Element Center Mats G Larson Chalmers Finite Element Center p.1 Outline We present an

More information

A Finite Element Method for the Surface Stokes Problem

A Finite Element Method for the Surface Stokes Problem J A N U A R Y 2 0 1 8 P R E P R I N T 4 7 5 A Finite Element Method for the Surface Stokes Problem Maxim A. Olshanskii *, Annalisa Quaini, Arnold Reusken and Vladimir Yushutin Institut für Geometrie und

More information

2018 Fall 2210Q Section 013 Midterm Exam II Solution

2018 Fall 2210Q Section 013 Midterm Exam II Solution 08 Fall 0Q Section 0 Midterm Exam II Solution True or False questions points 0 0 points) ) Let A be an n n matrix. If the equation Ax b has at least one solution for each b R n, then the solution is unique

More information

Stokes and the Surveyor s Shoelaces

Stokes and the Surveyor s Shoelaces Stokes and the Surveyor s Shoelaces Dr. LaLonde UT Tyler Math Club February 15, 2017 Finding Areas of Polygons Problem: Is there a way to quickly find the area of a polygon just by knowing where its vertices

More information

Isogeometric Analysis with Geometrically Continuous Functions on Two-Patch Geometries

Isogeometric Analysis with Geometrically Continuous Functions on Two-Patch Geometries Isogeometric Analysis with Geometrically Continuous Functions on Two-Patch Geometries Mario Kapl a Vito Vitrih b Bert Jüttler a Katharina Birner a a Institute of Applied Geometry Johannes Kepler University

More information

FEL3330 Networked and Multi-Agent Control Systems. Lecture 11: Distributed Estimation

FEL3330 Networked and Multi-Agent Control Systems. Lecture 11: Distributed Estimation FEL3330, Lecture 11 1 June 8, 2011 FEL3330 Networked and Multi-Agent Control Systems Lecture 11: Distributed Estimation Distributed Estimation Distributed Localization where R X is the covariance of X.

More information

Proper Orthogonal Decomposition (POD) for Nonlinear Dynamical Systems. Stefan Volkwein

Proper Orthogonal Decomposition (POD) for Nonlinear Dynamical Systems. Stefan Volkwein Proper Orthogonal Decomposition (POD) for Nonlinear Dynamical Systems Institute for Mathematics and Scientific Computing, Austria DISC Summerschool 5 Outline of the talk POD and singular value decomposition

More information

Maximum norm estimates for energy-corrected finite element method

Maximum norm estimates for energy-corrected finite element method Maximum norm estimates for energy-corrected finite element method Piotr Swierczynski 1 and Barbara Wohlmuth 1 Technical University of Munich, Institute for Numerical Mathematics, piotr.swierczynski@ma.tum.de,

More information

Model Reduction Methods

Model Reduction Methods Martin A. Grepl 1, Gianluigi Rozza 2 1 IGPM, RWTH Aachen University, Germany 2 MATHICSE - CMCS, Ecole Polytechnique Fédérale de Lausanne, Switzerland Summer School "Optimal Control of PDEs" Cortona (Italy),

More information

Vector Spaces, Affine Spaces, and Metric Spaces

Vector Spaces, Affine Spaces, and Metric Spaces Vector Spaces, Affine Spaces, and Metric Spaces 2 This chapter is only meant to give a short overview of the most important concepts in linear algebra, affine spaces, and metric spaces and is not intended

More information

From Completing the Squares and Orthogonal Projection to Finite Element Methods

From Completing the Squares and Orthogonal Projection to Finite Element Methods From Completing the Squares and Orthogonal Projection to Finite Element Methods Mo MU Background In scientific computing, it is important to start with an appropriate model in order to design effective

More information

Spin foam vertex and loop gravity

Spin foam vertex and loop gravity Spin foam vertex and loop gravity J Engle, R Pereira and C Rovelli Centre de Physique Théorique CNRS Case 907, Université de la Méditerranée, F-13288 Marseille, EU Roberto Pereira, Loops 07 Morelia 25-30

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

Basic Principles of Weak Galerkin Finite Element Methods for PDEs

Basic Principles of Weak Galerkin Finite Element Methods for PDEs Basic Principles of Weak Galerkin Finite Element Methods for PDEs Junping Wang Computational Mathematics Division of Mathematical Sciences National Science Foundation Arlington, VA 22230 Polytopal Element

More information

Finite Element Method for Ordinary Differential Equations

Finite Element Method for Ordinary Differential Equations 52 Chapter 4 Finite Element Method for Ordinary Differential Equations In this chapter we consider some simple examples of the finite element method for the approximate solution of ordinary differential

More information

MOTIVES ASSOCIATED TO SUMS OF GRAPHS

MOTIVES ASSOCIATED TO SUMS OF GRAPHS MOTIVES ASSOCIATED TO SUMS OF GRAPHS SPENCER BLOCH 1. Introduction In quantum field theory, the path integral is interpreted perturbatively as a sum indexed by graphs. The coefficient (Feynman amplitude)

More information