Linear Finite Element Methods

Size: px
Start display at page:

Download "Linear Finite Element Methods"

Transcription

1 Chapter 3 Linear Finite Element Methods The finite element methods provide spaces V n of functions that are piecewise smooth and simple, and locally supported basis function of these spaces to achieve good approximations of the solution u V, an efficient assembly of the system matrix with desirable properties (e g sparse and/or well conditioned) 31 Meshes A mesh M of the computational domain Ω R d, d = 1,, 3, is a collection of non-overlapping cells { i } M i=1, M := M, that are open, simply connected subsets i Ω Each cell i is a C -diffeomorphic image of a closed d-dimensional polytope the reference cell which is a convex hull of at least d + 1 points in R d Each cell i is an interval (d = 1), a Lipschitz polygon (d = ), or a Lipschitz polyhedron (d = 3) The mesh M contains a set of nodes (vertices) N (M), edges E(M) (d > 1), and faces F(M) (d = 3) (Sometimes the components of the mesh of dimension d 1 are called faces) The topology of the mesh is described by the connectivity of cells, faces, edges and nodes, e g, does a face belong to a cell, or more precisely, is a face contained in the closure of a cell A mesh is conforming if the intersection i j of (the closure of) any two adjacent cells i, j is a face of both cells A node of a mesh M that is located in the interior of a geometric face of one of its cells is known as hanging (dangling) node Grids are meshes with translation invariant structure These can be tensor product grids, that are meshes whose cells are quadrilaterals (d = ) or hexahedra (d = 3) with parallel sides Meshes are a crucial building block in the design of the finite dimensional trial and test spaces used in the finite element method, and provide subdomains for integration to build the system matrix and vector of the right hand side The orientation of geometric objects of the mesh is important for defining high order basis functions For an edge we have to define its direction For a face (d = 3) we have to specify an ordering of the edges along its boundary 5

2 (a) (b) (c) Figure 31: (a) Two-dimensional mesh and the sets of edges (red) and nodes (blue) (b) A geometrical node is not a topological node (c) A triangulation that is not conforming and possesses two hanging nodes Figure 3: Examples of triangular and quadrilateral grids in two dimensions Reference cell for triangles: reference triangle with nodes (, ), (1, ), (1, 1) for quadrilaterals: reference quad [, 1] or [, 1] for tetrahedra: reference tetrahedron with nodes (,, ), (1,, ), (, 1, ), (, 1, ) for prism: reference prism = reference triangle [, 1] for pyramid: reference pyramid with nodes (,, ), (1,, ), (1, 1, ), (, 1, ) and (5, 5, 1) for hexahedra: reference hexahedron [, 1] 3 In meshes with different cell types, we have more than one reference cell (a) Triangle (b) Quadrilateral (c) Tetrahedron (d) Prism (e) Pyramid (f) Hexahedron Figure 33: Cell types in D and 3D Affine mapping: linear, bijective mapping from a reference cell (triangle/parallelogram) to a physical cell (triangle/parallelogram) in the mesh Φ : R d R d, ξ Fξ + τ, F R d,d regular, τ R d (31) A mesh is called affine equivalent if all its cells arise as affine images of a single d-dimensional (reference) cell 6

3 Automatic mesh generation: can be given algorithms that create a mesh starting from a description of Ω which in terms of geometric primitives (ball, brick, etc) whose unions or intersections constitute Ω, by means of a parametrization of the faces of Ω, through a function f : R d R, whose sign indicates whether a point is located inside Ω or outside, by a mesh covering the surface of Ω and a direction of the exterior unit normal Various strategies can be employed for automatic grid generation: advancing front methods, that build cells starting from the boundary, Delaunay refinement techniques, that can create a mesh starting from a mesh for Ω or a cloud of points covering Ω, the quadtree (d = ) or octree (d = 3) approach, which fills Ω with squares/cubes of different sizes supplemented by special measures for resolving the boundary, and mapping techniques, that split Ω into subdomains of simple shape (curved triangles, parallelograms, bricks), endow those with parametric grids and glue these together Remark 31 Traditional codes for the solution of boundary value problems based on the finite element method usually read the geometry from a file describing the topology and geometry of the underlying mesh Then an approximate solution is computed and written to a file in order to be read by post-processing tools like visualization software, see Figure 34 Parameters Mesh generator Finite element solver (computational kernel) Post-processor (e g visualization) Figure 34: Flow of data in traditional finite element simulations Remark 3 A typical file format for a mesh of a simplicial conforming triangulation of a twodimensional polygonal domain is the following: # Two-dimensional simplicial mesh N N ξ 1 η 1 ξ η ξ N η N M N # Number of nodes # Coordinates of first node # Coordinates of second node # Coordinates of N-th node # Number of triangles n 1 1 n 1 n 1 3 X 1 # Indices of nodes of first triangle n 1 n n 3 X # Indices of nodes of second triangle n M 1 n M n M 3 X M # Indices of nodes of M-th triangle Here, X i, i = 1,, M, is an additional piece of information that may, for instance, describe what kind of material properties prevail in triangle #i In this case X i may be an integer index into a look-up table of material properties or the actual value of a coefficient function inside the triangle 7

4 Additional information about edges located on Ω may be provided in the following form: N # Number of edges on Ω n 1 1 n 1 Y 1 # Indices of endpoints of first edge n 1 n Y # Indices of endpoints of second edge n 1 n Y # Indices of endpoints of -th edge where Y k, k = 1,,, provides extra information about the type of boundary condition to be imposed on edge k Note that the ordering of the nodes in the above file formats implies an orientation of triangles and edges For a comprehensive account on mesh generation see [FG] An interesting algorithm for Delaunay meshing is described in [Rup95, She96] Free mesh generation software is also available, just to name some, netgen, gmsh, triangle, emc However, the most sophisticated mesh generation tools are commercial products and their algorithmic details are classified 3 Linear finite elements on triangular meshes 31 Basis functions 1 Figure 35: Finite element basis function b P (x) Let the domain Ω R be a polygon with a triangular conforming mesh M We define the finite element space of piecewise linear, continuous functions as S 1 (Ω, M) := {u C (Ω) : u(x) = a + bx 1 + cx, Proposition 33 (Properties of S 1 (Ω, M)) It holds S 1 (Ω, M) H 1 (Ω) P M} u S 1 (Ω, M) is uniquely defined by the values of u(p ) on the nodes P N (M) N = dim S 1 (Ω, M) = N < S 1 (Ω, M) = span{b P (x) : P N (M)}, with so called hat functions defined as b P S 1 (Ω, M), b P (P ) = δ P =P Let b be the vector of the basis functions Then, an arbitrary FE function v S 1 (Ω, M) can be written as v(x) = v(p )b P (x) = v b(x), so also the solution u n (x) = P N (M) P N (M) u n (P )b P (x) = u b(x) 8

5 3 Assembling of system matrix and load vector The support of the basis functions b P (x) consists of only a few triangles, such that the integrals in the (bi-)linear forms reduce to smaller sets and vanish for many pairs of basis functions Changing the point of view, we consider the shape functions, which are the restrictions of basis functions to one cell M For S 1 (Ω, M) these are exactly three, each for one node of The shape functions can be defined on a single cell as N,Pj()(x) = N j (Φ x), where N j are the element shape functions defined by N (ξ) = 1 ξ 1 ξ, Nj (ξ) = ξ j, j = 1,, on the reference element, which is the triangle with vertices (, ), (1, ), (, 1) P j () is the j-th node of the triangle, j =, 1,, with the coordinate p j Then, the (affine) element mapping reads x = Φ (ξ) = p + ξ 1 (p 1 p ) + ξ (p p ) = τ + F ξ, with F = (p 1 p, p p ) and τ = p As the element mapping is linear, the shape functions are in fact linear as well The basis functions result from the shape functions by glueing, i e, { N,Pj (x) x, P N (), P = P j (), b P (x) = otherwise This can be expressed by the connectivity matrices or T-matrices { T R 3,N 1, P j () = P i (M),, (T ) ij =, otherwise These T-matrices give a relation between the local number of (element) shape functions and global numbering of basis functions They have the form 1 T = 1 1 For the T-matrices an extremely sparse format is used For linear finite elements on triangles we have only to store the three indices P i, P i1 and P i of the three nodes in the triangle Now, we can express a basis function in one cell as and the system matrix is given with b Pi (x) = 3 (T) ki N,Pk ()(x), k=1 (B) ij = b(b Pj, b Pi ) = b (b Pj, b Pi ) = = = 3 b ( (T ) kj N,Pk (), 3 k=1 k=1 l=1 3 (T ) li N,Pl ()) l=1 3 (T ) kj (T ) li b (N,Pk (), N,Pl ()) (T ),jb (T ),i, i e, as sum of weighted element matrices B = T B T This means we have to integrate only over the shape functions, and to sum up the contributions over all the cells 9

6 Element stiffness matrix The bilinear form in the variational problem related to (14) consists of two parts, which contribute to the system matrix The first part a(u, v) = a u, v dx is constituting the stiffness matrix A We transform the derivatives to By chain rule of differentiation and with Ω we have and thus = ( x 1, x ), = ( ξ 1, ξ ), ξ1 N,Pj (x(ξ)) = x1 N,Pj (x) x 1 ξ 1 + x N,Pj (x) x ξ 1 ξ N,Pj (x(ξ)) = x1 N,Pj (x) x 1 ξ + x N,Pj (x) x ξ ) ( Φ N,Pj (x(ξ)) = N,Pj (x) ξ }{{} DΦ =F Hence, for triangular cells we obtain N,Pj (x) = F N,Pj (x(ξ)) = F N j (ξ) For a single cell the entries of the element stiffness matrix A are given by a (N,Pj, N,Pi ) = a(x)( N,Pj (x)) N,Pi (x)dx = a(φ ξ)( N j (ξ)) F F N i (ξ) F dξ = a(φ ξ)( N j (ξ)) adj(f )adj(f ) Ni (ξ) F dξ, where we used the relation of the inverse and the adjoint matrix F = F adj(f ) ( ) ( ) a b d b The adjoint matrix of a matrix is c d c a Note, that the gradient of the element shape functions are constant vectors ( ) ( ) ( ) N 1 =, N1 =, N = 1 So we can simplify (A ) ij = a (N,Pj, N,Pi ) = a ( N j ) adj(f )adj(f ) Ni F with the average heat conduction a = 1 a(x)dx in (Note that F = ) The latter simplifies for constant material or may be obtained by numerical quadrature for more general smooth functions Due to the special values of N j we can even simplify A = a 4 D D with a matrix D with coordinate differences ( ) y1 y D = y y y y 1 x x 1 x x x 1 x 3

7 Element mass matrix The mass matrix is related to the bilinear form m(u, v) = Ω c uv dx The element mass matrix M of the cell can be computed as m (N,Pj, N,Pi ) = c(x) N,Pj (x)n,pi (x) dx = In case of a constant function c in the cell we can write { 1 (M ) ij = 6 c i = j, 1 1 c i j Element load vector The element load vector is related to the linear form l (v) = fvdx c(φ ξ) N j (ξ) N i (ξ) F dξ For general, smooth function f we use numerical quadrature to evaluate the integrals quadrature rule is fvdx f(x )v(x ) The simplest where x is the barycenter of the cell As this quadrature rule is only exact for linear functions, and the shape functions are already linear, it will provide only reasonable results if f is (almost) constant in 33 Numerical quadrature Numerical quadrature for triangular cells are defined on the triangle with nodes (, ), (1, ), (, 1), where integrals over can easily transformed to 1 1 ξ1 f(ξ) dξ dξ 1 = ξ1 f( ξ1+1, ξ+1 ) dξ dξ n j=1 w j f( ξ1,j+1, ξ,j+1 ) There are Gauß quadrature rules for triangles which are exact for polynomials of maximal total degree 1,,, 5 and which use only 1, 3, 4, 6 and 7 points, respectively See, e g, page 141 in Šolín [Šol6] To get higher accuracies in a systematic matter there is, for example, the Duffy transformation, which transforms an integral over the reference triangle by an integral over a reference square and employs a tensor-product quadrature rule After applying the Duffy transformation, we integrate over ξ ξ ξ 1 = ξ 1 (1 ξ ) ξ = ξ ξ 1 ξ 1 Figure 36: Duffy transformation of a square into a triangle 31

8 the reference cell [, 1], so a tensor product of 1D quadrature rule can be applied The quadrature rules in 1D are, however, usually given in the interval [, 1] Hence, we have to transform 1D integrals via 1 f(ξ) dξ = 1 1 f( ξ+1 ) dξ 1 n j=1 w j f( ξj+1 ), where w j are the weights and ξ j the abscissas of the quadrature rule Accurate quadrature rule for smooth functions are variants of the Gauß quadrature The most wellknown is the Gauß-Legendre rule for which the abscissas are the zeros of the n-th Legendre polynomial P n (ξ) and the weights are given by (see [AS64, page 887]) w j = (1 ξ j )[P n(ξ j )] The Gauß-Legendre rule is exact for polynomials of degree n 1 and the remainder (for the interval [, 1]) is R n = (n!) 4 (n + 1)[(n)!] 3 f (n) (ξ), < ξ < 1 The zeros of the Legendre polynomials are tabulated (see [AS64, page 91ff]) and there is an algorithm (see Matlab version gaulegm on the webpage of the lecture) in the numerical recipes [PTFV7] The Gauß-Lobatto rule is only accurate for polynomials of degree n 3 However, both end-points are included in the set of abscissas For the square [, 1] we have the product quadrature rule 1 1 f(ξ) dξ 1 dξ = f( ξ1+1, ξ+1 ) dξ 1 dξ 1 4 n 1 n w i i=1 j=1 w j f( ξi+1, ξj+1 ), with n 1 and n quadrature points in the two directions It is important to note that the Duffy transformation changes the total polynomial degree To see this point, let us start with a definition Definition 34 Given a domain R d, d N, we write P m () := span{ξ ξ α := ξ α1 1 ξ α d d, α Nd, α m} for the vector space of d-variate polynomials of (total) degree m, m N If m = (m 1,, m d ) T N d we designate by Q m () := span{ξ ξ α1 1 ξ α d d, α k m k, 1 k d} the space of tensor product polynomials of maximal degree m k in the k-th coordinate direction Let = convex{ ( ), ( 1 ), ( 1 1) } and =], 1[ Then f(ξ 1, ξ ) dξ = f( ξ 1 (1 ξ ), ξ ) (1 ξ ) d ξ If f P m ( ), then the integrand on the right hand side will belong to Q m,m+1 ( ), i e the degree of polynomial is increased by one in the second variable The usage of numerical quadrature inevitably introduces another approximation, which will contribute to the overall discretization error The general rule is that The error due to numerical quadrature must not dominate the total discretization error in the relevant norms Remark 35 An alternative to numerical quadrature is polynomial interpolation followed by analytical evaluation of the localized integrals 3

9 34 A-priori estimate of the discretization error If the variational problem is elliptic (see Céa s lemma 8) the discretization error is bounded quasi optimally by the best approximation error u u n V b γ n inf u w n w V (3) n W n In case of more general bilinear forms that satisfy (IS1), (IS) and (DIS) we have ( u u n V 1 + b ) inf u w n γ n w V n W n For any u V we define some projection I n : V W n, that we can estimate Trivially, we have inf u w n w V u I n u V (33) n W n For example, for bounded functions u, e g, for u H (Ω) we can project onto the space of linear finite elements by I n u = u(p )b P (x), P N (M) which is an evaluation of the values on the nodes The interpolation operator of Raviart-Thomas is defined as (I n v)(x) := N l j (v)b j (x) j=1 where l j : V R/C are functionals, called global degrees of freedom Number of global degrees of freedom equals the number of basis functions Lemma 36 (Bramble-Hilbert lemma) If Ω R d is a bounded Lipschitz-domain and m N, then γ = γ(m, Ω) > : inf v p H p P m (Ω) γ v H m (Ω) v H m (Ω) m(ω) Generalization of Poincaré s inequality (Lemma 6) and a best approximation of polynomials in Sobolev spaces which is similar to the pointwise statement of Taylor s theorem The constant γ depends on the domain Using reference element is beneficial as the constant is then always the same The global degrees of freedom, e g, point evaluations, edge integrals or cell integrals, define on local degrees of freedom and the local interpolation operator Îû = (I n u)(x(ξ)), which acts on the pull-back û(ξ) = u(φ (ξ)) of u Estimate on the reference element Using the triangle inequality, the fact that there exists a constant C(t, m, ), 1 t m + 1 if d = 1 and t m + 1 if d =, 3, such that Îû H t ( ) C(t, m, ) û Ht ( ) for all û H t ( ), which follows from the continuous embedding of H t ( ) in C ( ) and, finally, using the Bramble-Hilbert lemma we obtain an estimate for the interpolation error of Î Let us measure the error in the H r -norm with r t m + 1 (t 1 for d = 1 and t for d =, 3) Then û Îû Hr ( ) û Îû Ht ( ) = inf (û p) Î(û p) p P m( ) Ht ( ) ( û inf p H t( p P m( ) ) + Î(û p) )) Ht( (34) (1 + C(t, m, )) inf p P m( ) û p Ht ( ) γ(m, )(1 + C(t, m, }{{ )) û } H t ( ) =C(t,m), since is fixed 33

10 Transformation techniques we transform Sobolev norms To apply the Bramble-Hilbert lemma on and transforming back to Lemma 37 If Φ : is an affine mapping ξ F ξ + τ, then, for all m N, ( ) m + d û Hm ( ) d m F m det(f ) / u d H m () u H m (), ( ) m + d u H m () d m F d m det(f ) 1 / û H m ( ) u H m ( ) with F denoting the matrix norm of F associated with the Euclidean vector norm Estimate on a cell With the transformation techniques presented above we can relate the interpolation error on with that one of the pull-back û u I n u r H r () = u I n u H l () l= r ( ) l + d d l F d l det(f ) û Î n u }{{} l= Îû H l ( ) ( ) r + d C(r) d r F d r det(f ) û Îû H r ( ) Using the estimate (34) on the reference element we get u I n u ( ) r + d C(r, t, m) Hr d r F () d r det(f ) 1 / û Ht ( ), and transformed back to u In u ( )( ) r + d t + d C(r, t, m) H d r+t F r () d d r F t u H t (), (35) }{{} C(d,t,r,m) with r t m + 1, t The estimate depends on the size and shape of the triangle through F Note that convergence in terms of h is only expected if the solution has higher regularity, i e, u H () if we measure in H 1 () Definition 38 Given a cell of a mesh M we define its diameter h := sup{ x y, x, y }, and the maximum radius of an inscribed ball r := sup{r > : x : x y < r y } The ratio ρ = h /r is called the shape regularity measure of r l α r h Figure 37: Diameter h and maximum radius r of an inscribed ball for a triangular cell Figure 38: Angle condition for shape regularity of a triangle The shape regularity measure of a simplex can be calculated from bounds for the smallest and largest angles enclosed by edge/face normals For triangles with the smallest angle α > we have sin( α /) ρ sin( α /) 34

11 Estimates for affine elements maps ρ 1 d M µ d M with the meshwidth h d M det(f ) h d M, F h M, F ρm µ M h M, (36) h M := max{h, M}, the shape regularity measure ρ M := max{ρ, M}, and the quasi-uniformity measure µ M := max{h /h,, M} = max{h, M} min{h, M} Interpolation error estimate in the mesh The interpolation error can be decomposed into the contributions from all triangles of M, using (35) and (36), and summing the errors from each triangle we get Theorem 39 Let I n stand for the finite element interpolation operator belonging to the finite element space S m (M) on a simplicial mesh M Then, for t m + 1, r t γ = γ(t, r, m, ρ M, µ M ) : u I n u H r (Ω) γ ht r M u H t (Ω) u H t (Ω) Discretization error in the mesh From (3) and (33), i e, from the fact that Discretization error best-approximation error interpolation error and Theorem 39 we can deduce that the discretization error satisfies u u n H 1 (Ω) γ ht M u H t (Ω) for t m + 1 and u H t (Ω), (37) where γ = γ(ω, γ n, b, ρ M, µ M, m, t) Discussion To expect convergence we need u to be of higher regularity For certain problems higher regularity u H r+ (Ω) is guaranteed by elliptic shift theorems if f H r (Ω), and the boundary and the boundary data are smooth The bound (37) can be interpreted as asymptotic a-priori error estimate u u n H 1 (Ω) = O(ht M n ) for n, where M n, n N, is a sequence of simplicial, uniformly shape-regular (ρ Mn < ρ max for all n N) meshes of Ω, that become infinitely fine (h Mn as n ) In other words, we obtain a convergence with the meshwidth of order t 1, which is equal to the polynomial degree if the solution u is sufficiently regular If Ω is convex or has C 1 -boundary, and a C 1 (Ω), then u u n L (Ω) γh M u u n H1 (Ω) with γ = γ(ω, a, m, ρ M, µ M ) > In other words, the weaker the norm of the discretization error the faster it converges to zero as h M A more sophisticated best approximation estimates for increasing polynomial degree, i e, m, t 1, reads inf u v n H v n S m (M) 1 (Ω) γ(ρ M, µ M ) ( ) min{m+1,t} hm u m Ht(Ω) (38) which is an a-priori error estimates for the p-version of H 1 -conforming finite elements 35

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

Finite Element Methods

Finite Element Methods Chapter 5 Finite Element Methods 5.1 Finite Element Spaces Remark 5.1 Mesh cells, faces, edges, vertices. A mesh cell is a compact polyhedron in R d, d {2,3}, whose interior is not empty. The boundary

More information

Parameterization of triangular meshes

Parameterization of triangular meshes Parameterization of triangular meshes Michael S. Floater November 10, 2009 Triangular meshes are often used to represent surfaces, at least initially, one reason being that meshes are relatively easy to

More information

AMS527: Numerical Analysis II

AMS527: Numerical Analysis II AMS527: Numerical Analysis II A Brief Overview of Finite Element Methods Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao SUNY Stony Brook AMS527: Numerical Analysis II 1 / 25 Overview Basic concepts Mathematical

More information

Parameterization. Michael S. Floater. November 10, 2011

Parameterization. Michael S. Floater. November 10, 2011 Parameterization Michael S. Floater November 10, 2011 Triangular meshes are often used to represent surfaces, at least initially, one reason being that meshes are relatively easy to generate from point

More information

arxiv: v1 [math.na] 20 Sep 2016

arxiv: v1 [math.na] 20 Sep 2016 arxiv:1609.06236v1 [math.na] 20 Sep 2016 A Local Mesh Modification Strategy for Interface Problems with Application to Shape and Topology Optimization P. Gangl 1,2 and U. Langer 3 1 Doctoral Program Comp.

More information

Lecture notes for Topology MMA100

Lecture notes for Topology MMA100 Lecture notes for Topology MMA100 J A S, S-11 1 Simplicial Complexes 1.1 Affine independence A collection of points v 0, v 1,..., v n in some Euclidean space R N are affinely independent if the (affine

More information

On a nested refinement of anisotropic tetrahedral grids under Hessian metrics

On a nested refinement of anisotropic tetrahedral grids under Hessian metrics On a nested refinement of anisotropic tetrahedral grids under Hessian metrics Shangyou Zhang Abstract Anisotropic grids, having drastically different grid sizes in different directions, are efficient and

More information

High Order Nédélec Elements with local complete sequence properties

High Order Nédélec Elements with local complete sequence properties High Order Nédélec Elements with local complete sequence properties Joachim Schöberl and Sabine Zaglmayr Institute for Computational Mathematics, Johannes Kepler University Linz, Austria E-mail: {js,sz}@jku.at

More information

Geometric structures on manifolds

Geometric structures on manifolds CHAPTER 3 Geometric structures on manifolds In this chapter, we give our first examples of hyperbolic manifolds, combining ideas from the previous two chapters. 3.1. Geometric structures 3.1.1. Introductory

More information

However, this is not always true! For example, this fails if both A and B are closed and unbounded (find an example).

However, this is not always true! For example, this fails if both A and B are closed and unbounded (find an example). 98 CHAPTER 3. PROPERTIES OF CONVEX SETS: A GLIMPSE 3.2 Separation Theorems It seems intuitively rather obvious that if A and B are two nonempty disjoint convex sets in A 2, then there is a line, H, separating

More information

Non-Linear Finite Element Methods in Solid Mechanics Attilio Frangi, Politecnico di Milano, February 3, 2017, Lesson 1

Non-Linear Finite Element Methods in Solid Mechanics Attilio Frangi, Politecnico di Milano, February 3, 2017, Lesson 1 Non-Linear Finite Element Methods in Solid Mechanics Attilio Frangi, attilio.frangi@polimi.it Politecnico di Milano, February 3, 2017, Lesson 1 1 Politecnico di Milano, February 3, 2017, Lesson 1 2 Outline

More information

SOLVING PARTIAL DIFFERENTIAL EQUATIONS ON POINT CLOUDS

SOLVING PARTIAL DIFFERENTIAL EQUATIONS ON POINT CLOUDS SOLVING PARTIAL DIFFERENTIAL EQUATIONS ON POINT CLOUDS JIAN LIANG AND HONGKAI ZHAO Abstract. In this paper we present a general framework for solving partial differential equations on manifolds represented

More information

THE MORTAR FINITE ELEMENT METHOD IN 2D: IMPLEMENTATION IN MATLAB

THE MORTAR FINITE ELEMENT METHOD IN 2D: IMPLEMENTATION IN MATLAB THE MORTAR FINITE ELEMENT METHOD IN D: IMPLEMENTATION IN MATLAB J. Daněk, H. Kutáková Department of Mathematics, University of West Bohemia, Pilsen MECAS ESI s.r.o., Pilsen Abstract The paper is focused

More information

Surface Mesh Generation

Surface Mesh Generation Surface Mesh Generation J.-F. Remacle Université catholique de Louvain September 22, 2011 0 3D Model For the description of the mesh generation process, let us consider the CAD model of a propeller presented

More information

Geometric structures on manifolds

Geometric structures on manifolds CHAPTER 3 Geometric structures on manifolds In this chapter, we give our first examples of hyperbolic manifolds, combining ideas from the previous two chapters. 3.1. Geometric structures 3.1.1. Introductory

More information

Lectures in Discrete Differential Geometry 3 Discrete Surfaces

Lectures in Discrete Differential Geometry 3 Discrete Surfaces Lectures in Discrete Differential Geometry 3 Discrete Surfaces Etienne Vouga March 19, 2014 1 Triangle Meshes We will now study discrete surfaces and build up a parallel theory of curvature that mimics

More information

Topological Data Analysis - I. Afra Zomorodian Department of Computer Science Dartmouth College

Topological Data Analysis - I. Afra Zomorodian Department of Computer Science Dartmouth College Topological Data Analysis - I Afra Zomorodian Department of Computer Science Dartmouth College September 3, 2007 1 Acquisition Vision: Images (2D) GIS: Terrains (3D) Graphics: Surfaces (3D) Medicine: MRI

More information

We have set up our axioms to deal with the geometry of space but have not yet developed these ideas much. Let s redress that imbalance.

We have set up our axioms to deal with the geometry of space but have not yet developed these ideas much. Let s redress that imbalance. Solid geometry We have set up our axioms to deal with the geometry of space but have not yet developed these ideas much. Let s redress that imbalance. First, note that everything we have proven for the

More information

A Flavor of Topology. Shireen Elhabian and Aly A. Farag University of Louisville January 2010

A Flavor of Topology. Shireen Elhabian and Aly A. Farag University of Louisville January 2010 A Flavor of Topology Shireen Elhabian and Aly A. Farag University of Louisville January 2010 In 1670 s I believe that we need another analysis properly geometric or linear, which treats place directly

More information

Shape Modeling and Geometry Processing

Shape Modeling and Geometry Processing 252-0538-00L, Spring 2018 Shape Modeling and Geometry Processing Discrete Differential Geometry Differential Geometry Motivation Formalize geometric properties of shapes Roi Poranne # 2 Differential Geometry

More information

Simplicial Hyperbolic Surfaces

Simplicial Hyperbolic Surfaces Simplicial Hyperbolic Surfaces Talk by Ken Bromberg August 21, 2007 1-Lipschitz Surfaces- In this lecture we will discuss geometrically meaningful ways of mapping a surface S into a hyperbolic manifold

More information

Convexity: an introduction

Convexity: an introduction Convexity: an introduction Geir Dahl CMA, Dept. of Mathematics and Dept. of Informatics University of Oslo 1 / 74 1. Introduction 1. Introduction what is convexity where does it arise main concepts and

More information

M3P1/M4P1 (2005) Dr M Ruzhansky Metric and Topological Spaces Summary of the course: definitions, examples, statements.

M3P1/M4P1 (2005) Dr M Ruzhansky Metric and Topological Spaces Summary of the course: definitions, examples, statements. M3P1/M4P1 (2005) Dr M Ruzhansky Metric and Topological Spaces Summary of the course: definitions, examples, statements. Chapter 1: Metric spaces and convergence. (1.1) Recall the standard distance function

More information

Topology optimization in B-spline space

Topology optimization in B-spline space Topology optimization in B-spline space Xiaoping Qian Mechanical, Materials, and Aerospace Engineering Department Illinois Institute of Technology Chicago, IL 60062, USA Email: qian@iit.edu Highlights

More information

3D Modeling Parametric Curves & Surfaces

3D Modeling Parametric Curves & Surfaces 3D Modeling Parametric Curves & Surfaces Shandong University Spring 2012 3D Object Representations Raw data Point cloud Range image Polygon soup Solids Voxels BSP tree CSG Sweep Surfaces Mesh Subdivision

More information

Element Quality Metrics for Higher-Order Bernstein Bézier Elements

Element Quality Metrics for Higher-Order Bernstein Bézier Elements Element Quality Metrics for Higher-Order Bernstein Bézier Elements Luke Engvall and John A. Evans Abstract In this note, we review the interpolation theory for curvilinear finite elements originally derived

More information

Linear Programming in Small Dimensions

Linear Programming in Small Dimensions Linear Programming in Small Dimensions Lekcija 7 sergio.cabello@fmf.uni-lj.si FMF Univerza v Ljubljani Edited from slides by Antoine Vigneron Outline linear programming, motivation and definition one dimensional

More information

Lecture 2 Unstructured Mesh Generation

Lecture 2 Unstructured Mesh Generation Lecture 2 Unstructured Mesh Generation MIT 16.930 Advanced Topics in Numerical Methods for Partial Differential Equations Per-Olof Persson (persson@mit.edu) February 13, 2006 1 Mesh Generation Given a

More information

The goal is the definition of points with numbers and primitives with equations or functions. The definition of points with numbers requires a

The goal is the definition of points with numbers and primitives with equations or functions. The definition of points with numbers requires a The goal is the definition of points with numbers and primitives with equations or functions. The definition of points with numbers requires a coordinate system and then the measuring of the point with

More information

Lecture 1 Discrete Geometric Structures

Lecture 1 Discrete Geometric Structures Lecture 1 Discrete Geometric Structures Jean-Daniel Boissonnat Winter School on Computational Geometry and Topology University of Nice Sophia Antipolis January 23-27, 2017 Computational Geometry and Topology

More information

Lecture 4: Convexity

Lecture 4: Convexity 10-725: Convex Optimization Fall 2013 Lecture 4: Convexity Lecturer: Barnabás Póczos Scribes: Jessica Chemali, David Fouhey, Yuxiong Wang Note: LaTeX template courtesy of UC Berkeley EECS dept. Disclaimer:

More information

Dual Complexes of Cubical Subdivisions of R n

Dual Complexes of Cubical Subdivisions of R n Dual Complexes of Cubical Subdivisions of R n Herbert Edelsbrunner and Michael Kerber Abstract We use a distortion to define the dual complex of a cubical subdivision of R n as an n-dimensional subcomplex

More information

CS 372: Computational Geometry Lecture 10 Linear Programming in Fixed Dimension

CS 372: Computational Geometry Lecture 10 Linear Programming in Fixed Dimension CS 372: Computational Geometry Lecture 10 Linear Programming in Fixed Dimension Antoine Vigneron King Abdullah University of Science and Technology November 7, 2012 Antoine Vigneron (KAUST) CS 372 Lecture

More information

Tutorial 3 Comparing Biological Shapes Patrice Koehl and Joel Hass

Tutorial 3 Comparing Biological Shapes Patrice Koehl and Joel Hass Tutorial 3 Comparing Biological Shapes Patrice Koehl and Joel Hass University of California, Davis, USA http://www.cs.ucdavis.edu/~koehl/ims2017/ What is a shape? A shape is a 2-manifold with a Riemannian

More information

Cell-Like Maps (Lecture 5)

Cell-Like Maps (Lecture 5) Cell-Like Maps (Lecture 5) September 15, 2014 In the last two lectures, we discussed the notion of a simple homotopy equivalences between finite CW complexes. A priori, the question of whether or not a

More information

9. Three Dimensional Object Representations

9. Three Dimensional Object Representations 9. Three Dimensional Object Representations Methods: Polygon and Quadric surfaces: For simple Euclidean objects Spline surfaces and construction: For curved surfaces Procedural methods: Eg. Fractals, Particle

More information

Differential Geometry: Circle Patterns (Part 1) [Discrete Conformal Mappinngs via Circle Patterns. Kharevych, Springborn and Schröder]

Differential Geometry: Circle Patterns (Part 1) [Discrete Conformal Mappinngs via Circle Patterns. Kharevych, Springborn and Schröder] Differential Geometry: Circle Patterns (Part 1) [Discrete Conformal Mappinngs via Circle Patterns. Kharevych, Springborn and Schröder] Preliminaries Recall: Given a smooth function f:r R, the function

More information

DM545 Linear and Integer Programming. Lecture 2. The Simplex Method. Marco Chiarandini

DM545 Linear and Integer Programming. Lecture 2. The Simplex Method. Marco Chiarandini DM545 Linear and Integer Programming Lecture 2 The Marco Chiarandini Department of Mathematics & Computer Science University of Southern Denmark Outline 1. 2. 3. 4. Standard Form Basic Feasible Solutions

More information

Mathematical Programming and Research Methods (Part II)

Mathematical Programming and Research Methods (Part II) Mathematical Programming and Research Methods (Part II) 4. Convexity and Optimization Massimiliano Pontil (based on previous lecture by Andreas Argyriou) 1 Today s Plan Convex sets and functions Types

More information

An introduction to mesh generation Part IV : elliptic meshing

An introduction to mesh generation Part IV : elliptic meshing Elliptic An introduction to mesh generation Part IV : elliptic meshing Department of Civil Engineering, Université catholique de Louvain, Belgium Elliptic Curvilinear Meshes Basic concept A curvilinear

More information

Contents. I The Basic Framework for Stationary Problems 1

Contents. I The Basic Framework for Stationary Problems 1 page v Preface xiii I The Basic Framework for Stationary Problems 1 1 Some model PDEs 3 1.1 Laplace s equation; elliptic BVPs... 3 1.1.1 Physical experiments modeled by Laplace s equation... 5 1.2 Other

More information

A Hash Data Structure for Adaptive PDE Solvers Based on Discontinuous Galerkin Discretizations

A Hash Data Structure for Adaptive PDE Solvers Based on Discontinuous Galerkin Discretizations A Hash Data Structure for Adaptive PDE Solvers Based on Discontinuous Galerkin Discretizations Kolja Brix, Ralf Massjung, and Alexander Voß Bericht Nr. 302 Juli 2009 Key words: Discontinuous Galerkin method,

More information

Lecture 0: Reivew of some basic material

Lecture 0: Reivew of some basic material Lecture 0: Reivew of some basic material September 12, 2018 1 Background material on the homotopy category We begin with the topological category TOP, whose objects are topological spaces and whose morphisms

More information

Approximating Polygonal Objects by Deformable Smooth Surfaces

Approximating Polygonal Objects by Deformable Smooth Surfaces Approximating Polygonal Objects by Deformable Smooth Surfaces Ho-lun Cheng and Tony Tan School of Computing, National University of Singapore hcheng,tantony@comp.nus.edu.sg Abstract. We propose a method

More information

Geometric Modeling in Graphics

Geometric Modeling in Graphics Geometric Modeling in Graphics Part 10: Surface reconstruction Martin Samuelčík www.sccg.sk/~samuelcik samuelcik@sccg.sk Curve, surface reconstruction Finding compact connected orientable 2-manifold surface

More information

Lecture 3. Corner Polyhedron, Intersection Cuts, Maximal Lattice-Free Convex Sets. Tepper School of Business Carnegie Mellon University, Pittsburgh

Lecture 3. Corner Polyhedron, Intersection Cuts, Maximal Lattice-Free Convex Sets. Tepper School of Business Carnegie Mellon University, Pittsburgh Lecture 3 Corner Polyhedron, Intersection Cuts, Maximal Lattice-Free Convex Sets Gérard Cornuéjols Tepper School of Business Carnegie Mellon University, Pittsburgh January 2016 Mixed Integer Linear Programming

More information

Numerical Methods for PDEs : Video 11: 1D FiniteFebruary Difference 15, Mappings Theory / 15

Numerical Methods for PDEs : Video 11: 1D FiniteFebruary Difference 15, Mappings Theory / 15 22.520 Numerical Methods for PDEs : Video 11: 1D Finite Difference Mappings Theory and Matlab February 15, 2015 22.520 Numerical Methods for PDEs : Video 11: 1D FiniteFebruary Difference 15, Mappings 2015

More information

Galerkin Projections Between Finite Element Spaces

Galerkin Projections Between Finite Element Spaces Galerkin Projections Between Finite Element Spaces Ross A. Thompson Thesis submitted to the Faculty of the Virginia Polytechnic Institute and State University in partial fulfillment of the requirements

More information

Two Algorithms for Approximation in Highly Complicated Planar Domains

Two Algorithms for Approximation in Highly Complicated Planar Domains Two Algorithms for Approximation in Highly Complicated Planar Domains Nira Dyn and Roman Kazinnik School of Mathematical Sciences, Tel-Aviv University, Tel-Aviv 69978, Israel, {niradyn,romank}@post.tau.ac.il

More information

Fully discrete Finite Element Approximations of Semilinear Parabolic Equations in a Nonconvex Polygon

Fully discrete Finite Element Approximations of Semilinear Parabolic Equations in a Nonconvex Polygon Fully discrete Finite Element Approximations of Semilinear Parabolic Equations in a Nonconvex Polygon Tamal Pramanick 1,a) 1 Department of Mathematics, Indian Institute of Technology Guwahati, Guwahati

More information

Quadratic and cubic b-splines by generalizing higher-order voronoi diagrams

Quadratic and cubic b-splines by generalizing higher-order voronoi diagrams Quadratic and cubic b-splines by generalizing higher-order voronoi diagrams Yuanxin Liu and Jack Snoeyink Joshua Levine April 18, 2007 Computer Science and Engineering, The Ohio State University 1 / 24

More information

= f (a, b) + (hf x + kf y ) (a,b) +

= f (a, b) + (hf x + kf y ) (a,b) + Chapter 14 Multiple Integrals 1 Double Integrals, Iterated Integrals, Cross-sections 2 Double Integrals over more general regions, Definition, Evaluation of Double Integrals, Properties of Double Integrals

More information

Convex Optimization. 2. Convex Sets. Prof. Ying Cui. Department of Electrical Engineering Shanghai Jiao Tong University. SJTU Ying Cui 1 / 33

Convex Optimization. 2. Convex Sets. Prof. Ying Cui. Department of Electrical Engineering Shanghai Jiao Tong University. SJTU Ying Cui 1 / 33 Convex Optimization 2. Convex Sets Prof. Ying Cui Department of Electrical Engineering Shanghai Jiao Tong University 2018 SJTU Ying Cui 1 / 33 Outline Affine and convex sets Some important examples Operations

More information

3D Modeling Parametric Curves & Surfaces. Shandong University Spring 2013

3D Modeling Parametric Curves & Surfaces. Shandong University Spring 2013 3D Modeling Parametric Curves & Surfaces Shandong University Spring 2013 3D Object Representations Raw data Point cloud Range image Polygon soup Surfaces Mesh Subdivision Parametric Implicit Solids Voxels

More information

Möbius Transformations in Scientific Computing. David Eppstein

Möbius Transformations in Scientific Computing. David Eppstein Möbius Transformations in Scientific Computing David Eppstein Univ. of California, Irvine School of Information and Computer Science (including joint work with Marshall Bern from WADS 01 and SODA 03) Outline

More information

Lecture 25: Bezier Subdivision. And he took unto him all these, and divided them in the midst, and laid each piece one against another: Genesis 15:10

Lecture 25: Bezier Subdivision. And he took unto him all these, and divided them in the midst, and laid each piece one against another: Genesis 15:10 Lecture 25: Bezier Subdivision And he took unto him all these, and divided them in the midst, and laid each piece one against another: Genesis 15:10 1. Divide and Conquer If we are going to build useful

More information

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

Scientific Computing WS 2018/2019. Lecture 12. Jürgen Fuhrmann Lecture 12 Slide 1 Scientific Computing WS 2018/2019 Lecture 12 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 12 Slide 1 Recap For more discussion of mesh generation, see J.R. Shewchuk: Lecture Notes on Delaunay

More information

arxiv: v2 [math.na] 2 Oct 2015

arxiv: v2 [math.na] 2 Oct 2015 INTERPOLATION ERROR ESTIMATES FOR HARMONIC COORDINATES ON POLYTOPES ANDREW GILLETTE AND ALEXANDER RAND arxiv:1504.00599v2 [math.na] 2 Oct 2015 Abstract. Interpolation error estimates in terms of geometric

More information

4. Definition: topological space, open set, topology, trivial topology, discrete topology.

4. Definition: topological space, open set, topology, trivial topology, discrete topology. Topology Summary Note to the reader. If a statement is marked with [Not proved in the lecture], then the statement was stated but not proved in the lecture. Of course, you don t need to know the proof.

More information

MA651 Topology. Lecture 4. Topological spaces 2

MA651 Topology. Lecture 4. Topological spaces 2 MA651 Topology. Lecture 4. Topological spaces 2 This text is based on the following books: Linear Algebra and Analysis by Marc Zamansky Topology by James Dugundgji Fundamental concepts of topology by Peter

More information

GEOMETRY MODELING & GRID GENERATION

GEOMETRY MODELING & GRID GENERATION GEOMETRY MODELING & GRID GENERATION Dr.D.Prakash Senior Assistant Professor School of Mechanical Engineering SASTRA University, Thanjavur OBJECTIVE The objectives of this discussion are to relate experiences

More information

Lecture 2 September 3

Lecture 2 September 3 EE 381V: Large Scale Optimization Fall 2012 Lecture 2 September 3 Lecturer: Caramanis & Sanghavi Scribe: Hongbo Si, Qiaoyang Ye 2.1 Overview of the last Lecture The focus of the last lecture was to give

More information

Locally convex topological vector spaces

Locally convex topological vector spaces Chapter 4 Locally convex topological vector spaces 4.1 Definition by neighbourhoods Let us start this section by briefly recalling some basic properties of convex subsets of a vector space over K (where

More information

Adaptive numerical methods

Adaptive numerical methods METRO MEtallurgical TRaining On-line Adaptive numerical methods Arkadiusz Nagórka CzUT Education and Culture Introduction Common steps of finite element computations consists of preprocessing - definition

More information

Euler Characteristic

Euler Characteristic Euler Characteristic Beifang Chen September 2, 2015 1 Euler Number There are two rules to follow when one counts the number of objects of finite sets. Given two finite sets A, B, we have (1) Addition Principle

More information

HPC Computer Aided CINECA

HPC Computer Aided CINECA HPC Computer Aided Engineering @ CINECA Raffaele Ponzini Ph.D. CINECA SuperComputing Applications and Innovation Department SCAI 16-18 June 2014 Segrate (MI), Italy Outline Open-source CAD and Meshing

More information

Module: 2 Finite Element Formulation Techniques Lecture 3: Finite Element Method: Displacement Approach

Module: 2 Finite Element Formulation Techniques Lecture 3: Finite Element Method: Displacement Approach 11 Module: 2 Finite Element Formulation Techniques Lecture 3: Finite Element Method: Displacement Approach 2.3.1 Choice of Displacement Function Displacement function is the beginning point for the structural

More information

2D Spline Curves. CS 4620 Lecture 18

2D Spline Curves. CS 4620 Lecture 18 2D Spline Curves CS 4620 Lecture 18 2014 Steve Marschner 1 Motivation: smoothness In many applications we need smooth shapes that is, without discontinuities So far we can make things with corners (lines,

More information

CAT(0)-spaces. Münster, June 22, 2004

CAT(0)-spaces. Münster, June 22, 2004 CAT(0)-spaces Münster, June 22, 2004 CAT(0)-space is a term invented by Gromov. Also, called Hadamard space. Roughly, a space which is nonpositively curved and simply connected. C = Comparison or Cartan

More information

Polygonal, Polyhedral, and Serendipity Finite Element Methods

Polygonal, Polyhedral, and Serendipity Finite Element Methods Polygonal, Polyhedral, and Serendipity Finite Element Methods Andrew Gillette Department of Mathematics University of Arizona ASU Computational and Applied Math Seminar Slides and more info at: http://math.arizona.edu/

More information

MATH 54 - LECTURE 10

MATH 54 - LECTURE 10 MATH 54 - LECTURE 10 DAN CRYTSER The Universal Mapping Property First we note that each of the projection mappings π i : j X j X i is continuous when i X i is given the product topology (also if the product

More information

Advanced Operations Research Techniques IE316. Quiz 1 Review. Dr. Ted Ralphs

Advanced Operations Research Techniques IE316. Quiz 1 Review. Dr. Ted Ralphs Advanced Operations Research Techniques IE316 Quiz 1 Review Dr. Ted Ralphs IE316 Quiz 1 Review 1 Reading for The Quiz Material covered in detail in lecture. 1.1, 1.4, 2.1-2.6, 3.1-3.3, 3.5 Background material

More information

Combinatorial Geometry & Topology arising in Game Theory and Optimization

Combinatorial Geometry & Topology arising in Game Theory and Optimization Combinatorial Geometry & Topology arising in Game Theory and Optimization Jesús A. De Loera University of California, Davis LAST EPISODE... We discuss the content of the course... Convex Sets A set is

More information

Spline Curves. Spline Curves. Prof. Dr. Hans Hagen Algorithmic Geometry WS 2013/2014 1

Spline Curves. Spline Curves. Prof. Dr. Hans Hagen Algorithmic Geometry WS 2013/2014 1 Spline Curves Prof. Dr. Hans Hagen Algorithmic Geometry WS 2013/2014 1 Problem: In the previous chapter, we have seen that interpolating polynomials, especially those of high degree, tend to produce strong

More information

When implementing FEM for solving two-dimensional partial differential equations, integrals of the form

When implementing FEM for solving two-dimensional partial differential equations, integrals of the form Quadrature Formulas in Two Dimensions Math 57 - Finite Element Method Section, Spring Shaozhong Deng, PhD (shaodeng@unccedu Dept of Mathematics and Statistics, UNC at Charlotte When implementing FEM for

More information

Computational Fluid Dynamics - Incompressible Flows

Computational Fluid Dynamics - Incompressible Flows Computational Fluid Dynamics - Incompressible Flows March 25, 2008 Incompressible Flows Basis Functions Discrete Equations CFD - Incompressible Flows CFD is a Huge field Numerical Techniques for solving

More information

Lab - Introduction to Finite Element Methods and MATLAB s PDEtoolbox

Lab - Introduction to Finite Element Methods and MATLAB s PDEtoolbox Scientific Computing III 1 (15) Institutionen för informationsteknologi Beräkningsvetenskap Besöksadress: ITC hus 2, Polacksbacken Lägerhyddsvägen 2 Postadress: Box 337 751 05 Uppsala Telefon: 018 471

More information

Surfaces: notes on Geometry & Topology

Surfaces: notes on Geometry & Topology Surfaces: notes on Geometry & Topology 1 Surfaces A 2-dimensional region of 3D space A portion of space having length and breadth but no thickness 2 Defining Surfaces Analytically... Parametric surfaces

More information

Adaptive Isogeometric Analysis by Local h-refinement with T-splines

Adaptive Isogeometric Analysis by Local h-refinement with T-splines Adaptive Isogeometric Analysis by Local h-refinement with T-splines Michael Dörfel 1, Bert Jüttler 2, Bernd Simeon 1 1 TU Munich, Germany 2 JKU Linz, Austria SIMAI, Minisymposium M13 Outline Preliminaries:

More information

A TESSELLATION FOR ALGEBRAIC SURFACES IN CP 3

A TESSELLATION FOR ALGEBRAIC SURFACES IN CP 3 A TESSELLATION FOR ALGEBRAIC SURFACES IN CP 3 ANDREW J. HANSON AND JI-PING SHA In this paper we present a systematic and explicit algorithm for tessellating the algebraic surfaces (real 4-manifolds) F

More information

Documentation for Numerical Derivative on Discontinuous Galerkin Space

Documentation for Numerical Derivative on Discontinuous Galerkin Space Documentation for Numerical Derivative on Discontinuous Galerkin Space Stefan Schnake 204 Introduction This documentation gives a guide to the syntax and usage of the functions in this package as simply

More information

Two Algorithms for Adaptive Approximation of Bivariate Functions by Piecewise Linear Polynomials on Triangulations

Two Algorithms for Adaptive Approximation of Bivariate Functions by Piecewise Linear Polynomials on Triangulations Two Algorithms for Adaptive Approximation of Bivariate Functions by Piecewise Linear Polynomials on Triangulations Nira Dyn School of Mathematical Sciences Tel Aviv University, Israel First algorithm from

More information

LECTURE 13, THURSDAY APRIL 1, 2004

LECTURE 13, THURSDAY APRIL 1, 2004 LECTURE 13, THURSDAY APRIL 1, 2004 FRANZ LEMMERMEYER 1. Parametrizing Curves of Genus 0 As a special case of the theorem that curves of genus 0, in particular those with the maximal number of double points,

More information

Spline Functions on Triangulations

Spline Functions on Triangulations Spline Functions on Triangulations MING-JUN LAI AND LARRY L. SCHUMAKER CAMBRIDGE UNIVERSITY PRESS Contents Preface xi Chapter 1. Bivariate Polynomials 1.1. Introduction 1 1.2. Norms of Polynomials on Triangles

More information

4. Simplicial Complexes and Simplicial Homology

4. Simplicial Complexes and Simplicial Homology MATH41071/MATH61071 Algebraic topology Autumn Semester 2017 2018 4. Simplicial Complexes and Simplicial Homology Geometric simplicial complexes 4.1 Definition. A finite subset { v 0, v 1,..., v r } R n

More information

Surface Reconstruction. Gianpaolo Palma

Surface Reconstruction. Gianpaolo Palma Surface Reconstruction Gianpaolo Palma Surface reconstruction Input Point cloud With or without normals Examples: multi-view stereo, union of range scan vertices Range scans Each scan is a triangular mesh

More information

Introduction to Geometry

Introduction to Geometry Introduction to Geometry This course covers the topics outlined below. You can customize the scope and sequence of this course to meet your curricular needs. Curriculum (211 topics + 6 additional topics)

More information

Manifolds. Chapter X. 44. Locally Euclidean Spaces

Manifolds. Chapter X. 44. Locally Euclidean Spaces Chapter X Manifolds 44. Locally Euclidean Spaces 44 1. Definition of Locally Euclidean Space Let n be a non-negative integer. A topological space X is called a locally Euclidean space of dimension n if

More information

Simplicial Global Optimization

Simplicial Global Optimization Simplicial Global Optimization Julius Žilinskas Vilnius University, Lithuania September, 7 http://web.vu.lt/mii/j.zilinskas Global optimization Find f = min x A f (x) and x A, f (x ) = f, where A R n.

More information

Scientific Computing: Interpolation

Scientific Computing: Interpolation Scientific Computing: Interpolation Aleksandar Donev Courant Institute, NYU donev@courant.nyu.edu Course MATH-GA.243 or CSCI-GA.22, Fall 25 October 22nd, 25 A. Donev (Courant Institute) Lecture VIII /22/25

More information

High-Dimensional Computational Geometry. Jingbo Shang University of Illinois at Urbana-Champaign Mar 5, 2018

High-Dimensional Computational Geometry. Jingbo Shang University of Illinois at Urbana-Champaign Mar 5, 2018 High-Dimensional Computational Geometry Jingbo Shang University of Illinois at Urbana-Champaign Mar 5, 2018 Outline 3-D vector geometry High-D hyperplane intersections Convex hull & its extension to 3

More information

60 2 Convex sets. {x a T x b} {x ã T x b}

60 2 Convex sets. {x a T x b} {x ã T x b} 60 2 Convex sets Exercises Definition of convexity 21 Let C R n be a convex set, with x 1,, x k C, and let θ 1,, θ k R satisfy θ i 0, θ 1 + + θ k = 1 Show that θ 1x 1 + + θ k x k C (The definition of convexity

More information

1.2 Numerical Solutions of Flow Problems

1.2 Numerical Solutions of Flow Problems 1.2 Numerical Solutions of Flow Problems DIFFERENTIAL EQUATIONS OF MOTION FOR A SIMPLIFIED FLOW PROBLEM Continuity equation for incompressible flow: 0 Momentum (Navier-Stokes) equations for a Newtonian

More information

Tiling Three-Dimensional Space with Simplices. Shankar Krishnan AT&T Labs - Research

Tiling Three-Dimensional Space with Simplices. Shankar Krishnan AT&T Labs - Research Tiling Three-Dimensional Space with Simplices Shankar Krishnan AT&T Labs - Research What is a Tiling? Partition of an infinite space into pieces having a finite number of distinct shapes usually Euclidean

More information

ADAPTIVE FINITE ELEMENT METHODS FOR ELLIPTIC PDEs BASED ON CONFORMING CENTROIDAL VORONOI DELAUNAY TRIANGULATIONS

ADAPTIVE FINITE ELEMENT METHODS FOR ELLIPTIC PDEs BASED ON CONFORMING CENTROIDAL VORONOI DELAUNAY TRIANGULATIONS SIAM J. SCI. COMPUT. Vol. 8, No. 6, pp. 3 53 c 6 Society for Industrial and Applied Mathematics ADAPTIVE FINITE ELEMENT METHODS FOR ELLIPTIC PDEs BASED ON CONFORMING CENTROIDAL VORONOI DELAUNAY TRIANGULATIONS

More information

Orientation of manifolds - definition*

Orientation of manifolds - definition* Bulletin of the Manifold Atlas - definition (2013) Orientation of manifolds - definition* MATTHIAS KRECK 1. Zero dimensional manifolds For zero dimensional manifolds an orientation is a map from the manifold

More information

Topological Issues in Hexahedral Meshing

Topological Issues in Hexahedral Meshing Topological Issues in Hexahedral Meshing David Eppstein Univ. of California, Irvine Dept. of Information and Computer Science Outline I. What is meshing? Problem statement Types of mesh Quality issues

More information

Lecture 2. Topology of Sets in R n. August 27, 2008

Lecture 2. Topology of Sets in R n. August 27, 2008 Lecture 2 Topology of Sets in R n August 27, 2008 Outline Vectors, Matrices, Norms, Convergence Open and Closed Sets Special Sets: Subspace, Affine Set, Cone, Convex Set Special Convex Sets: Hyperplane,

More information

CURVILINEAR MESH GENERATION IN 3D

CURVILINEAR MESH GENERATION IN 3D CURVILINEAR MESH GENERATION IN 3D Saikat Dey, Robert M. O'Bara 2 and Mark S. Shephard 2 SFA Inc. / Naval Research Laboratory, Largo, MD., U.S.A., dey@cosmic.nrl.navy.mil 2 Scientific Computation Research

More information