PDE & FEM TERMINOLOGY. BASIC PRINCIPLES OF FEM.

Size: px
Start display at page:

Download "PDE & FEM TERMINOLOGY. BASIC PRINCIPLES OF FEM."

Transcription

1 PDE & FEM TERMINOLOGY. BASIC PRINCIPLES OF FEM. Sergey Korotov Basque Center for Applied Mathematics / IKERBASQUE & 1

2 Introduction The analytical solution of problems described by partial differential equations (PDEs) is known only in a few cases on special domains (like balls, cubes, half-spaces, etc). It is often necessary to use some numerical methods to get an approximation of this solution. One of the most powerful numerical methods for solving PDEs is the Galerkin method. The standard finite element method (FEM) is, roughly speaking, the Galerkin method with a special choice of basis functions. 2

3 The FEM has been developed during last 70 years. The discovery of FEM is usually attributed to Richard Courant [Courant, 1943]. However, in [Ciarlet, Lions] we can find some older references to finite element-like methods. The first monograph on FEM is probably that of Synge [Synge] of The notion element was introduced in the 1950-th by aerospace engineers performing elasticity computations as they devided a continuum into small pieces called elements. The notion finite element was introduced by mathematicians later, in the 1960-th. From that time the theory of FEM has also been rigorously investigated. R. Courant. Variational methods for problems of equilibrium and vibration. Bull. Amer. Math. Soc. 49 (1943), P. G. Ciarlet, J. L. Lions (eds.). Handbook of Numerical Analysis. Vol. II Finite element methods. North-Holland, Amsterdam, J. L. Synge. The Hypercircle in Mathematical Physics. Cambridge Univ. Press, Cambridge,

4 Nowadays FEM seems to be one of the most efficient numerical methods for solving problems of mathematical physics which are based on variational principles. One may solve by FEM some variational problems which do not correspond to any PDEs (e.g. the obstacle problem). Moreover, FEM enables perfect description of the examined domain, which was not possible by classical numerical methods (such as the collocation method, finite difference method, etc.). 4

5 The flow-chart of numerical simulation: No Continue with analytical (non computer) methods of solution A physical problem to be solved Set up mathematical description of the problem (mathematical problem) Is a computer solution to be considered? Yes Establish mathematical model into form suitable for numerical solution Perform discretization and solve the resulting discrete problem Check correctness of numerical results There are many ways how to set up a mathematical model and then design it into a form suitable for numerical solution. In our case it will be so that we give a variational formulation of the problem in an appropriate function space: We want to find a function minimizing a convex functional over a closed set of admissible functions. The basic idea of the discretization will consist then in transforming the problem formulated in function spaces with infinite dimension into appropriate problems in finite-dimensional spaces. 5

6 First we shall remind a variational (weak) formulation of problems described by second order PDEs of elliptic type with some boundary conditions. This formulation is useful in explaining the mathematical background of FEM and is based on the theory of Sobolev spaces. Sobolev spaces are extensions of spaces of differentiable functions in the classical sense. Such extensions are natural as the solution of a variational problem usually does not have the classical derivatives. 6

7 Model Problem In a bounded domain with a Lipschitz boundary, consider the following second order PDE for the unknown function u C 2 (): d i,j=1 x i ( ) u a ij +cu = f. x j Here c,f C() and the matrix A = (a ij ) (C 1 ()) d d are given. We further assume that a ij = a ji, i,j = 1,...,d, c(x) 0, x, and that there is a constant M > 0 such that d i,j=1 a ij (x)ξ i ξ j M d ξi 2 (ξ 1,...,ξ d ) T R d, x. i=1 The above assumptions ensure that our model problem is elliptic. 7

8 Three (standard) types of boundary conditions characterizing the (homogeneous) Dirichlet, Neumann and Newton classical problem: u = 0 on, n A u = 0 on, αu+ n A u = 0 on. Here α = α(s) 0 on is continuous, n A u = d i,j=1 a ij u x j n i = n T Agradu denotes the conormal derivative, n i are the components of the unit outward normal to and n A = An is the conormal. The vector function Agradu on is said to be the cogradient and the scalar function n T Agradu the boundary flux. 8

9 The model PDE with one of the above boundary conditions represents the so-called boundary value problem (BVP) (classically formulated). The function u C 2 () satisfying the PDE and the associated boundary condition is called the classical solution. Such BVP may describe a stationary magnetic, electric, or temperature fields, etc. The coefficients a ij describe physical properties of the medium. If a ij are constants (i.e., independent of x), we call the medium homogeneous (otherwise nonhomogeneous). If a ii (x) = a 11 (x) for i = 2,...,d, and a ij (x) = 0 for i j, the medium is said to be isotropic (otherwise anisotropic). If A is only diagonal, the medium is orthotropic. In real-life problems the coefficients a ij, c, α are often nonsmooth (they are, e.g., piecewise constant) and we cannot use the equation as it stands, since the classical derivatives in it need not exist. This is why we introduce a weak formulation of the classical problems, which enables us to consider also nonsmooth coefficients and/or nonsmooth f. 9

10 Consider e.g. the Newton classical problem and introduce the space of test functions V := H 1 (). Multiplying the PDE by an arbitrary test function v V and integrating over we get i,j x i ( ) u a ij vdx+ cuvdx = x j fvdx. Employing now Green s formula, we find that i,j u v u a ij dx a ij n i vds+ cuvdx = x j x i x j i,j fvdx. Using further the boundary condition, we obtain that i,j u v a ij dx+ cuvdx+ αuvds = x j x i fvdx v V. 10

11 We see that any classical solution of the Newton problem (if it exists) satisfies the equation i,j u v a ij dx+ cuvdx+ αuvds = x j x i fvdx v V. ( ) Let us observe that the integrals in above are well defined even when a ij, c L (), α L ( ), f L 2 (), and when prescribed conditions on the coefficients hold almost everywhere (a.e.) in only. When introducing the space of test functions V we started to use implicitly the concept of completion. Instead of looking for u C 2 () satisfying the PDE and the boundary condition, we shall solve the integral form equation ( ). Its solution will be searched in the Hilbert space H 1 (), which is, of course, complete and bigger than C 2 (). This allows us to employ some useful results from functional analysis (e.g. Lax-Milgram lemma) and apply the finite element method. 11

12 Weak Solution The function u H 1 () is called the weak (or generalized) solution of the Newton problem if i,j u v a ij dx+ cuvdx+ αuvds = x j x i fvdx v V. ( ) For convenience the weak solution is denoted by u as the classical solution. Note that the classical solution from C 2 () need not exist. However, if it does exist, it is also the weak solution. Notice further that the weak formulation ( ) contains only the first (generalized) derivatives of u which may be advantageous for approximation. 12

13 In order to establish under what conditions the problem posed in a weak form has a unique solution in the Sobolev space H 1 (), we recall some definitions and present two abstract theorems. Let V be a linear space. A mapping a(, ) : V V R 1 is called a bilinear form, if for any fixed v V the mappings a(v, ) : V R 1 and a(,v) : V R 1 are linear. If, in addition, a(v,w) = a(w,v) v,w V, the bilinear form a(, ) is said to be symmetric. 13

14 Theorem 1: Let V be a Banach space equipped with the norm V and let F : V R 1 be a continuous linear form. Let a(, ) : V V R 1 be a symmetric and continuous bilinear form, i.e., there exists C 1 > 0 such that a(v,w) C 1 v V w V v,w V. Moreover, we suppose that there exists C 2 > 0 such that a(v,v) C 2 v 2 V v V (V-ellipticity condition). Then the problem: Find u V such that a(u, v) = F(v) v V (variational equality) has one and only one solution. 14

15 P r o o f : Due to the symmetry of a(, ) and V-ellipticity, the bilinear form a(, ) is a scalar product on V since a(v,v) = 0 implies v = 0. The corresponding norm a(, ) is, obviously, equivalent to the given norm V. Thus V equipped with the scalar product a(, ) is a Hilbert space. Since F( ) is a continuous linear form, there exists by the Riesz representation theorem a unique element u = u F V such that F(v) = a(u F,v) v V. 15

16 Theorem 2: Let all the assumptions of the previous theorem be fulfilled. Then the problem: Find u V such that a(u,v) = F(v) v V, is equivalent to the problem: Find u V such that where J(u) = inf v V J(v), J(v) = 1 2 a(v,v) F(v). 16

17 Functional J(v) = 1 a(v,v) F(v) is called the energy functional. 2 Norm a(, ) (equivalent to V -norm) is called the energy norm. To apply Theorem 1 to the weak formulation ( ) we set a(v,w) = V = H 1 (), v w a ij dx+ cvwdx+ x j x i i,j F(v) = fvdx, v V αvwds, v,w V, and verify whether all the assumptions of the theorem are fulfilled. 17

18 Useful Inequalities Let be a bounded domain with a Lipschitz boundary and let v,w H 1 (). Then v L 2 ( ), v L 2 ( ) C v H 1 () (trace theorem), v wdx+ v w dx = x j x j vwn j ds (Green s formula), 18

19 v H 1 () C ( d ( v j=1 x j ) 2 dx+ 0 v 2 ds )1 2 (Friedrichs inequality), where 0 is such that meas 0 > 0, v H 1 () C ( d ( v j=1 x j ) 2 dx+ B v 2 dx)12 (X), where B is a ball, v H 1 () C ( d ( v j=1 x j ) 2 dx+( vdx) 2 )12 (Poincaré s inequality). For the proof, see [Dautray, Lions, vol. 2], [Nečas, 1967]. 19

20 V is a Hilbert space. a(v,w) = i,j v w a ij dx+ cvwdx+ αvwds, v,w V, x j x i F(v) = fvdx, v V The linearity of F( ) and bilinearity of a(, ) are obvious. The continuity of F( ) follows immediately from the Cauchy-Schwarz inequality F(v) = as 0, 1,. fvdx f 0, v 0, f 0, v 1, 20

21 a(v,w) = i,j v w a ij dx+ cvwdx+ αvwds, v,w V, x j x i The bilinear form is symmetric as a ij = a ji and continuous as: d a(v,w) a ij L () v w x i 0, x j i,j=1 0, + c L () v 0, w 0, + α L ( ) v L 2 ( ) w L 2 ( ) C v 1, w 1,, where we used the trace theorem and the relation d v 2 1, = v 2 0, + v 2 x j j=1 0,. 21

22 What remains is to prove the V-ellipticity condition for a(v,w) = i,j v w a ij dx+ cvwdx+ αvw ds, x j x i Suppose that α(x) α 0 > 0 on some part 0 which has a positive measure. Then we can use Friedrichs inequality, and get a(v,v) M d ( ) 2 v dx+α 0 i=1 x i 0 v 2 ds C v 2 1,. So, in this case the variational problem ( ) has a unique solution by virtue of Theorem 1. 22

23 Another situation. a(v,w) = i,j v w a ij dx+ cvwdx+ αvw ds, x j x i Let now c(x) c 0 > 0 on a ball B. Then we get the V-ellipticity in a view of inequality (X): a(v,v) M d ( ) 2 v dx+c 0 i=1 x i B v 2 dx C v 2 1,, which gives the existence of just one solution u V. 23

24 We can show that the weak solution of ( ) belonging to C 2 () is also the classical solution of the Newton problem. If c = 0 in and simultaneously α = 0 on then we get the so-called Neumann problem, which requires a special treatment (not to be considered now). We can similarly handle the Dirichlet problem. For the space of test functions, we choose V = H 1 0() = { v H 1 () v = 0 on }. Now from Friedrichs inequality we immediately find that the associated symmetric bilinear form a(v,w) = i,j v w a ij dx+ cvwdx, v,w V, x j x i fulfils the V-ellipticity condition. 24

25 Consider now the nonhomogeneous mixed boundary conditions: u = ū on Γ 1, n A u = g on Γ 2, αu+ n A u = g on Γ 3, where ū H 1 (), g L 2 (Γ 2 Γ 3 ), α L (Γ 3 ), α 0, Γ 1,Γ 2,Γ 3 are mutually disjoint and are open sets in (one or two of them may be empty), Γ 0 Γ 1 Γ 2 Γ 3 =, and Γ 0 (meas Γ 0 = 0) is a set of those points where one type of boundary condition changes into another. 25

26 In order to apply the FEM later, we shall assume from now on that each set Γ i (i = 1,2,3) has a finite number of components. Let the space of test functions be chosen as follows: V = {v H 1 () v = 0 on Γ 1 }. 26

27 If the problem with the above mixed boundary conditions is not purely Neumann with c = 0 then the corresponding variational formulation consists in finding u = u 0 +ū, where u 0 V satisfies a(u 0,v) = F(v) v V, and where v w a(v,w) = a ij dx+ cvwdx x j x i i,j + αvwds, v,w V, Γ 3 F(v) = fvdx+ gvds a(ū,v), v V. Γ 2 Γ 3 The desired V-ellipticity condition follows again from Friedrichs inequality or (X). Note that it may be sometimes difficult to find ū H 1 () with prescribed values on Γ 1. 27

28 Lax-Milgram Lemma Sometimes we need to solve an elliptic problem whose associated bilinear form a(, ) is not symmetric. Then, instead of Theorem 1, the following theorem (often called Lax-Milgram lemma in the numerical analysis) is applied. Theorem 3: Let V be a Hilbert space, let a(, ) : V V R 1 be a continuous V-elliptic bilinear form and let F : V R 1 be a continuous linear form. Then the problem: Find u V such that a(u,v) = F(v) v V, has one and only one solution. If a(, ) is not symmetric then there is no associated minimization problem as in Theorem 2. 28

29 Basic Idea of FEM Now we shall show how to construct finite element subspaces V h of V. The FEM in its simplest setting is a Galerkin method characterized by the following basic aspects in the construction of V h : (i) a triangulation T h is established over the domain, (ii) the functions v h V h are piecewise polynomials, (iii) there exists a basis in V h whose functions have small supports. The so-called discretization parameter h is associated with a characteristic size of triangulations used - it will be defined more precisely later. 29

30 Let now V h be an arbitrary finite-dimensional subspace of V. Then the Galerkin method for approximating the solution of the problem: Find u V such that a(u,v) = F(v) v V, consists of finding u h V h such that a(u h,v h ) = F(v h ) v h V h. ( ) Applying Lax-Milgram lemma, we observe that this problem has one and only one solution u h, which we shall call the discrete solution. 30

31 When a(, ) is symmetric, the discrete solution is also characterized by the property (see Theorem 2) where J(u h ) = inf v h V h J(v h ), J(v) = 1 2 a(v,v) F(v). This definition of discrete solution is known as the Ritz method. Note that J(u) J(u h ), since V h V. 31

32 Obviously, we have the following orthogonality relation a(u u h,v h ) = 0 v h V h, which means that the error u u h is orthogonal to V h with respect to the scalar product a(, ). This orthogonality relation implies that u h is the projection of u on V h with respect to a(, ) and that a(u u h,u u h ) = inf v h V h a(u v h,u v h ), i.e. the Ritz method yields the best approximation with respect to the energy norm. 32

33 Let a(, ) be not necessarily symmetric. And let {v i } m i=1 be basis in V h. We shall look for the discrete solution u h as a linear combination u h = m c j v j. j=1 Then by ( ) it is true that ( m ) a c j v j,v i = F(v i ), i = 1,...,m. j=1 This finally leads to the following system of algebraic equations: m a j=1 ( v j,v i) c j = F(v i ), i = 1,...,m, ( ) for the unknowns c 1,...,c m. 33

34 The matrix A = ( a(v j,v i ) ) m and the vector ( F(v i ) ) m are often i,j=1 i=1 called (by reference to elasticity problems) the stiffness matrix and the load vector, respectively. We prove that A is nonsingular. From the bilinearity of a(, ) and the V-ellipticity condition we have (Aξ,ξ) = ( a(v j,v i )ξ i ξ j = a ξ j v j, ) ξ i v i = a(v,v) i,j j i C 2 v 2 V > 0 ξ = (ξ 1,...,ξ m ) T R m, ξ 0, where v = ξ i v i, and v 0 since {v i } is a basis and ξ 0. Hence, the i homogeneous equation Aξ = 0 cannot have a nontrivial solution ξ 0. 34

35 The discrete solution u h is obviously independent of basis functions v 1,...,v m V h, whereas the structure of A depends considerably on v 1,...,v m. Thus, concerning the choice of the basis {v i }, it is very important from the numerical point of view that the matrix A possesses as many zero entries as possible. For instance, if the intersection of the supports of basis functions v p and v q has zero measure then a(v p,v q ) = 0. That is why the condition (iii) is required. It may even happen that a(v p,v q ) = 0, p q, though the intersection of supports has a positive measure. Thus according to (iii), only a few entries (more precisely O(m) entries) of the m m stiffness matrix A remain different from zero, i.e., A is sparse. Hence, we need less computer memory and fewer arithmetic operations to solve ( ) than for full matrices which arise, in general, from the classical Galerkin method. 35

36 In order to introduce some typical V h, we first establish a triangulation T h over domain, i.e., we subdivide the set into a finite number of subsets K (called elements) in such a way that the following properties hold: (1) = K T h K, (2) for each K T h, the set K is closed and its interior K 0 is non-empty, (3) for each distinct K 1,K 2 T h, one has K 0 1 K 0 2 =, (4) for each K T h, the boundary K is the Lipschitz one. Later we shall give further assumptions on T h. The discretization parameter h is the maximum diameter of all K T h. Note that there is a certain ambiguity in the meaning of T h as for a given sufficiently small h there may exist many different triangulations T h. Nevertheless, we will keep this often used notation. Sometimes T h is called a partition or a decomposition of into elements. From now on we shall write H k (K) instead of H k (K 0 ) for simplicity. 36

37 In what follows we shall construct finite element spaces V h consisting of piecewise polynomial functions over T h. An important property of such spaces is given in the following theorem. Theorem 4: Let T h be a triangulation (decomposition) of formed by convex elements. Let V h be a subspace of L 2 () such that the space P K = {v h K v h V h } consists of polynomial functions for any K T h. Then V h H 1 () iff V h C(), i.e. a piecewise polynomial function is from H 1 () iff it is continuous. 37

38 P r o o f : So let V h H 1 () and let there exist a function v h V h which is not continuous. Then there exist two adjacent elements K 1, K 2 T h and an open ball B K 1 K 2 such that B S and v h K1 > v h K2 on B S, where S = K 1 K 2. Let w C 0 () be a hill function such that w(x) > 0 x B and w(x) = 0 x \B. Denote by n j = (n j 1,...,nj d )T the outward unit normal to K j, j = 1,2. We see that S is contained in a hyperplane of R d as K 1 and K 2 are convex. Therefore n j is constant on S and there exists i {1,...,d} such that n 1 i 0. 38

39 Now, referring to Green s formula, we arrive at 0 = = = v h w wdx+ v h dx = x i x i 2 ( j=1 K j v h x i wdx+ 2 ( w v h dx+ v h Kj wn j i j=1 K j x ds+ i K j ) (v h K1 v h K2 wn 1 i ds = n 1 i S B S ) w v h dx K j x i ) w v h dx K j x i (v h K1 v h K2 )wds. But this is a contradiction, since n 1 i 0 and the last integral is positive due to our assumptions upon w and the piecewise polynomial function v h. 39

40 Conversely, let v h V h be continuous. Then evidently v h L 2 () and we show that it has also the first generalized derivatives in L 2 (). Since any K has a Lipschitz boundary and P K H 1 (K) for all K T h, we may apply Green s formula for i {1,...,d} to get v h w wdx+ v h dx = v h K wn K i ds w C0 (), ( ) x i x i K K K where n K i is the ith component of the unit outward normal to K. Let z i L 2 () be defined through the relation z i K = v h x i, K T h. 40

41 Summing ( ) over all the elements K T h, we obtain z i w wdx+ v h dx = v h K wn K i ds. x i K T h We see, however, that the sum vanishes. Either a portion of K is a portion of the boundary, where w = 0, or the contribution of any two adjacent elements K,K T h is zero as n K +n K = 0. Hence, z i w wdx = v h dx w C0 () x i and the functions z i, i = 1,...,d, are the first generalized derivatives of v h. Thus we may write z i = v h / x i in the whole. K 41

42 The theorem can be also modified to the case when P K contains generally nonpolynomial functions from C(K) H 1 (K) and for nonconvex elements. This may be useful to construct some more complicated spaces of finite elements. Suppose further that in the case d 2 elements of T h are convex polygons or polyhedra, which is fulfilled quite often. Then is, of course, a polygon or polyhedron. We add two more assumptions upon T h : (5) any face of any K T h is either a subset of the boundary, or a face of another element K T h, (6) the interior of any face of any K T h is disjoint with Γ 0, where Γ 0 is a set of those points where one type of boundary condition changes into another. 42

43 Remark: For any generally nonconvex polygon (polyhedron) there exists a triangulation T h satisfying (1) (5) such that all the elements K T h are triangles (tetrahedra). Construction can be done as follows. Let S 1,...,S q be faces of and let L 1,...,L q be straight lines (planes) such that S j L j. First show that components of the set \ q j=1 Lj are convex. Then cut these components into simplexes so that (5) holds. 43

44 Finite Elements The following general definition of the finite element will be used to construct finite element spaces V h. Definition: The finite element is a triple (K,P,Σ), where: (I) K is a closed subset of R d with a non-empty interior and a Lipschitz boundary, (II) P is a space of real-valued functions defined over the set K, (III) Σ is a finite set of linearly independent linear forms Φ i, 1 i N, defined over the space P (or over a space which contains P). 44

45 The set Σ is said to be P-unisolvent if for any real scalars α i, 1 i N, there exists a unique function p P which satisfies Φ i (p) = α i, 1 i N. Consequently, if Σ is P-unisolvent then there exist functions p i P, 1 i N, which satisfy Φ j (p i ) = δ ij, 1 j N, where δ ij is Kronecker s symbol. Since p P p = N Φ i (p)p i, i=1 we have dimp = N. The linear forms Φ i, 1 i N, are called the degrees of freedom of the finite element, and the functions p i, 1 i N, are called the basis functions of the finite element. 45

46 In what follows we introduce several examples of the most used finite elements, where K will be a convex set of a simple form and P a space of polynomials. Functions from P are sometimes called ansatz-functions. The space of all polynomials of degree at most k defined on K is denoted by P k (K). We introduce only some lower order elements, since the use of higher order elements requires certain higher smoothness of the true solution, which is usually not present in practical problems. 46

47 Linear simplicial element The set K is a d-simplex, the space P = P K is the space P 1 (K) of linear functions p(x 1,...,x d ) = γ 0 +γ 1 x γ d x d, γ i R 1, dimp 1 (K) = d+1. A 3 A 4 A 3 A A A A A 1 A 2 47

48 The set of degrees of freedom Σ = Σ K consists of the forms Φ i (p) = p(a i ), 1 i d+1, p P 1 (K), where A 1,...,A d+1 are the vertices of K. For the sake of simplicity we shall write only symbolically Σ K = {p(a i ), 1 i d+1}. 1 A 3 p 1 1 p 1 A 1 A 2 A 1 A 2 In the case d = 2, this element is also known as Courant s triangle (element). The first basis function p 1 is sketched above for d = 1,2. 48

49 Quadratic simplicial element K is again a d-simplex, P K = P 2 (K) is the space of quadratic functions p(x 1,...,x d ) = γ 0 + d γ i x i + γ ij x i x j, γ i,γ ij R 1, i=1 1 i j d and Σ K = {p(a i ), 1 i d+1; p(a ij ), 1 i < j d+1}, where A i are the vertices of K and A ij = 1 2 (A i +A j ), 1 i < j d+1, are the midpoints of the edges of the d-simplex K: 49

50 A 3 A 34 A 4 A 13 A A A A A 1 A A 23 2 A 3 A 13 A 1 A A 14 A A 24 A 2 We may easily check that dimp 2 (K) = 1 2 (d+1)(d+2). 50

51 Two figures in below show two qualitatively different types of basis functions of the quadratic element for d = 1 and d = 2, respectively: 51

52 Bilinear and trilinear rectangular elements Here K is a d-rectangle, P K = Q 1 (K) is the space of d-linear functions p(x 1,...,x d ) = γ q1...q d x q x q d d, γ q1...q d R 1 0 q i 1,1 i d (for d = 2 and d = 3 these functions are called bilinear and trilinear polynomials, respectively), dimq 1 (K) = 2 d and { Σ K = p(a i ), 1 i 2 d}, where A i are the vertices of K. A 4 A 3 A 5 A 84 7 A 6 A A 1 A 2 A 4 A 3 A 1 A 2 52

53 Prismatic element The set K is a prismatic domain. The space P K is the tensor product of the space P 1 in variables x 1,x 2 by the space Q 1 in the variable x 3, i.e. dim P K = 6 and P K consists of polynomials of the form p(x 1,x 2,x 3 ) = γ 0 +γ 1 x 1 +γ 2 x 2 +γ 3 x 3 +γ 4 x 1 x 3 +γ 5 x 2 x 3, γ i R 1, and Σ K = {p(a i ), 1 i 6}, where A i are again the vertices of K. A 4 A 6 A 5 x 3 A 1 A 3 x 1 x 2 A 2 53

54 All the previous elements are called Lagrange finite elements since the degrees of freedom are of the form p p(a), A K. The point A is then called the node. These elements are P K -unisolvent, i.e, given any (α 1,...,α N ) T R N there exists just one polynomial p P K such that, for all the nodes A 1,...,A N, p(a i ) = α i holds. If at least one directional derivative occurs as a degree of freedom, the associated finite element is said to be a Hermite finite element. 54

55 As an example we introduce the Hermite cubic element which is also P K -unisolvent. Here K is a triangle, P K = P 3 (K) is the space of cubic polynomials, and { Σ K = p(a i ), p x 1 (A i ), } p (A i ), i = 1,2,3 ; p(g) x 2 where A i are the vertices of K and G is its centre of gravity., A 3 G A 1 A 2 55

56 Some other types of degrees of freedom often used in FEM: Φ(p) = p (A) normal derivative n Φ(p) = (D i p)(a), i 1 higher order derivative Φ(p) = K p(x)dx integral over the element K Φ(v) = n 1 v 1 (A)+ +n d v d (A) normal component of vector-function(v 1,...,v d ) T Note that, in engineering literature, the degrees of freedom of a finite element are sometimes called parameters. 56

57 Finite Element Spaces We shall give now a description of a finite element space generated by Lagrange elements (K,P K,Σ K ), K T h. The sets of degrees of freedom of adjacent finite elements will be related as follows: Whenever (K l,p Kl,Σ Kl ) with Σ Kl = {p(a l i), 1 i N l }, l = 1,2, are two adjacent finite elements, then ) {A 1 i} ( N1 K 2 = ) {A 2 i} ( N2 K 1. i=1 i=1 Let us denote this set by N S, where S = K 1 K 2. 57

58 Note that the situation in below cannot occur due to property (5). K 2 K 1 When we want to joint adjacent finite elements, we moreover need that {p 1 S p 1 P K1 } = {p 2 S p 2 P K2 }. We denote this space by P S. Finally suppose that if p P S and p(a) = 0 for all A N S, then p = 0 on S. 58

59 Let us define the set N h = K T h N K, where, for each finite element (K,P K,Σ K ), the symbol N K denotes the set of nodes. The associated finite element space X h is then given by X h = {v h C() v h K P K K T h }. Therefore a function in the space X h is uniquely determined by the set Σ h = {v(a), A N h }, which is called the set of degrees of freedom of the finite element space X h. Given values at nodal points, we always get a continuous function. 59

60 An example of function from X h defined by the linear finite elements for d = 2. 60

61 According to Theorem 4 and the consistency condition (6) we define finite element subspaces of the space by V = {v H 1 () v = 0 on Γ 1 }. V h = {v h X h v h (A) = 0 for A N h Γ 1 } V. It is really a subspace of V, as v h = 0 on Γ 1, by our assumptions. 61

62 To guarantee the requirement (iii) we choose the basis {v i } m i=1 V h v i (A j ) = δ ij, where m = dimv h, i,j = 1,...,m, A i N h, and A i Γ

63 Let for example d = 1, = (0,1), a(v,w) = ( v x, w ), v,w H0(), 1 x 0, and 0 < A 1 < A 2 < < A m < 1. Then a(v i,v j ) = ( v i x, vj x ) 0,suppv i suppv j and the standard Courant basis functions yield a(v i,v j ) = 0 whenever i j > 1. Thus we see that the matrix A = (a(v i,v j )) m i,j=1 is only tridiagonal. For d > 1 the nodes can be numbered so that A is a band matrix. 63

64 When is piecewise curved, there are several ways of constructing finite element spaces. One way is to generate them by the so-called isoparametric (curved) elements. Note that a curved element, K need not be convex and P K may be formed e.g. by rational functions. K Another way is to approximate by a polygonal (polyhedral) domain h and then to extend finite element functions from h to the whole in an appropriate manner. 64

65 Consider for instance a bounded plane domain with a Lipschitz boundary which consists of a finite number of smooth convex and concave arcs. h The sides of h are chords or tangents of convex or concave arcs, respectively. The points of inflexion of coincide with some vertices of h. 65

66 For such a polygon h there is a triangulation T h consisting of triangles such that the maximum length of all their sides equals h. Let us define the space of continuous piecewise linear functions as follows V h = {v h C() v h K P 1 (K) K T h, v h \h = 0}. We see now that V h is entirely contained in the space of test functions V = H0() 1 for the homogeneous Dirichlet problem. Note that in the case of the mixed boundary conditions, the parts Γ 2 and Γ 3 need not be approximated by polygonal curves and we still have V h V. 66

67 When V h V, and when the bilinear and linear form of the discrete problem are identical to the original ones, the finite element method is said to be conforming. That was the case before. h A nonconforming method arises when V h V or when e.g. some numerical integration is used. Figure in above shows another manner of boundary approximation which is often used in practice and which also yields V h V. A nonconforming method is also obtained when the function u H 1 () from the Dirichlet boundary condition is approximized by a piecewise polynomial continuous function. 67

LECTURE 1: SOURCES OF ERRORS MATHEMATICAL TOOLS A PRIORI ERROR ESTIMATES. Sergey Korotov,

LECTURE 1: SOURCES OF ERRORS MATHEMATICAL TOOLS A PRIORI ERROR ESTIMATES. Sergey Korotov, LECTURE 1: SOURCES OF ERRORS MATHEMATICAL TOOLS A PRIORI ERROR ESTIMATES Sergey Korotov, Institute of Mathematics Helsinki University of Technology, Finland Academy of Finland 1 Main Problem in Mathematical

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

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

Variational Formulations

Variational Formulations Chapter 2 Variational Formulations In this chapter we will derive a variational (or weak) formulation of the elliptic boundary value problem (1.4). We will discuss all fundamental theoretical results that

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

DISCRETE MAXIMUM PRINCIPLES in THE FINITE ELEMENT SIMULATIONS

DISCRETE MAXIMUM PRINCIPLES in THE FINITE ELEMENT SIMULATIONS DISCRETE MAXIMUM PRINCIPLES in THE FINITE ELEMENT SIMULATIONS Sergey Korotov BCAM Basque Center for Applied Mathematics http://www.bcamath.org 1 The presentation is based on my collaboration with several

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

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

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

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

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

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 Sobolev Embedding Theorems Embedding Operators and the Sobolev Embedding Theorem

More information

Chapter 5 A priori error estimates for nonconforming finite element approximations 5.1 Strang s first lemma

Chapter 5 A priori error estimates for nonconforming finite element approximations 5.1 Strang s first lemma Chapter 5 A priori error estimates for nonconforming finite element approximations 51 Strang s first lemma We consider the variational equation (51 a(u, v = l(v, v V H 1 (Ω, and assume that the conditions

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

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

Math Tune-Up Louisiana State University August, Lectures on Partial Differential Equations and Hilbert Space

Math Tune-Up Louisiana State University August, Lectures on Partial Differential Equations and Hilbert Space Math Tune-Up Louisiana State University August, 2008 Lectures on Partial Differential Equations and Hilbert Space 1. A linear partial differential equation of physics We begin by considering the simplest

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

The maximum angle condition is not necessary for convergence of the finite element method

The maximum angle condition is not necessary for convergence of the finite element method 1 2 3 4 The maximum angle condition is not necessary for convergence of the finite element method Antti Hannukainen 1, Sergey Korotov 2, Michal Křížek 3 October 19, 2010 5 6 7 8 9 10 11 12 13 14 15 16

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

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

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

Second Order Elliptic PDE

Second Order Elliptic PDE Second Order Elliptic PDE T. Muthukumar tmk@iitk.ac.in December 16, 2014 Contents 1 A Quick Introduction to PDE 1 2 Classification of Second Order PDE 3 3 Linear Second Order Elliptic Operators 4 4 Periodic

More information

Chapter 2 Finite Element Spaces for Linear Saddle Point Problems

Chapter 2 Finite Element Spaces for Linear Saddle Point Problems Chapter 2 Finite Element Spaces for Linear Saddle Point Problems Remark 2.1. Motivation. This chapter deals with the first difficulty inherent to the incompressible Navier Stokes equations, see Remark

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

[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

DS-GA 1002 Lecture notes 0 Fall Linear Algebra. These notes provide a review of basic concepts in linear algebra.

DS-GA 1002 Lecture notes 0 Fall Linear Algebra. These notes provide a review of basic concepts in linear algebra. DS-GA 1002 Lecture notes 0 Fall 2016 Linear Algebra These notes provide a review of basic concepts in linear algebra. 1 Vector spaces You are no doubt familiar with vectors in R 2 or R 3, i.e. [ ] 1.1

More information

An a posteriori error estimate and a Comparison Theorem for the nonconforming P 1 element

An a posteriori error estimate and a Comparison Theorem for the nonconforming P 1 element Calcolo manuscript No. (will be inserted by the editor) An a posteriori error estimate and a Comparison Theorem for the nonconforming P 1 element Dietrich Braess Faculty of Mathematics, Ruhr-University

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

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

A Mixed Nonconforming Finite Element for Linear Elasticity

A Mixed Nonconforming Finite Element for Linear Elasticity A Mixed Nonconforming Finite Element for Linear Elasticity Zhiqiang Cai, 1 Xiu Ye 2 1 Department of Mathematics, Purdue University, West Lafayette, Indiana 47907-1395 2 Department of Mathematics and Statistics,

More information

Finite Element Methods for Fourth Order Variational Inequalities

Finite Element Methods for Fourth Order Variational Inequalities Louisiana State University LSU Digital Commons LSU Doctoral Dissertations Graduate School 2013 Finite Element Methods for Fourth Order Variational Inequalities Yi Zhang Louisiana State University and Agricultural

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 WEAK GALERKIN MIXED FINITE ELEMENT METHOD FOR BIHARMONIC EQUATIONS

A WEAK GALERKIN MIXED FINITE ELEMENT METHOD FOR BIHARMONIC EQUATIONS A WEAK GALERKIN MIXED FINITE ELEMENT METHOD FOR BIHARMONIC EQUATIONS LIN MU, JUNPING WANG, YANQIU WANG, AND XIU YE Abstract. This article introduces and analyzes a weak Galerkin mixed finite element method

More information

PREPRINT 2010:25. Fictitious domain finite element methods using cut elements: II. A stabilized Nitsche method ERIK BURMAN PETER HANSBO

PREPRINT 2010:25. Fictitious domain finite element methods using cut elements: II. A stabilized Nitsche method ERIK BURMAN PETER HANSBO PREPRINT 2010:25 Fictitious domain finite element methods using cut elements: II. A stabilized Nitsche method ERIK BURMAN PETER HANSBO Department of Mathematical Sciences Division of Mathematics CHALMERS

More information

A brief introduction to finite element methods

A brief introduction to finite element methods CHAPTER A brief introduction to finite element methods 1. Two-point boundary value problem and the variational formulation 1.1. The model problem. Consider the two-point boundary value problem: Given a

More information

Numerical Methods for the Navier-Stokes equations

Numerical Methods for the Navier-Stokes equations Arnold Reusken Numerical Methods for the Navier-Stokes equations January 6, 212 Chair for Numerical Mathematics RWTH Aachen Contents 1 The Navier-Stokes equations.............................................

More information

Construction of `Wachspress type' rational basis functions over rectangles

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

More information

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

Numerical Methods for Partial Differential Equations

Numerical Methods for Partial Differential Equations Numerical Methods for Partial Differential Equations Eric de Sturler University of Illinois at Urbana-Champaign Read section 8. to see where equations of type (au x ) x = f show up and their (exact) solution

More information

FINITE ELEMENT METHODS

FINITE ELEMENT METHODS FINITE ELEMENT METHODS Lecture notes arxiv:1709.08618v1 [math.na] 25 Sep 2017 Christian Clason September 25, 2017 christian.clason@uni-due.de https://udue.de/clason CONTENTS I BACKGROUND 1 overview of

More information

Finite difference method for elliptic problems: I

Finite difference method for elliptic problems: I Finite difference method for elliptic problems: I Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in/~praveen

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

Approximation in Banach Spaces by Galerkin Methods

Approximation in Banach Spaces by Galerkin Methods 2 Approximation in Banach Spaces by Galerkin Methods In this chapter, we consider an abstract linear problem which serves as a generic model for engineering applications. Our first goal is to specify the

More information

Lecture Note III: Least-Squares Method

Lecture Note III: Least-Squares Method Lecture Note III: Least-Squares Method Zhiqiang Cai October 4, 004 In this chapter, we shall present least-squares methods for second-order scalar partial differential equations, elastic equations of solids,

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

Solutions of Selected Problems

Solutions of Selected Problems 1 Solutions of Selected Problems October 16, 2015 Chapter I 1.9 Consider the potential equation in the disk := {(x, y) R 2 ; x 2 +y 2 < 1}, with the boundary condition u(x) = g(x) r for x on the derivative

More information

CONVERGENCE THEORY. G. ALLAIRE CMAP, Ecole Polytechnique. 1. Maximum principle. 2. Oscillating test function. 3. Two-scale convergence

CONVERGENCE THEORY. G. ALLAIRE CMAP, Ecole Polytechnique. 1. Maximum principle. 2. Oscillating test function. 3. Two-scale convergence 1 CONVERGENCE THEOR G. ALLAIRE CMAP, Ecole Polytechnique 1. Maximum principle 2. Oscillating test function 3. Two-scale convergence 4. Application to homogenization 5. General theory H-convergence) 6.

More information

WEAK GALERKIN FINITE ELEMENT METHODS ON POLYTOPAL MESHES

WEAK GALERKIN FINITE ELEMENT METHODS ON POLYTOPAL MESHES INERNAIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume 12, Number 1, Pages 31 53 c 2015 Institute for Scientific Computing and Information WEAK GALERKIN FINIE ELEMEN MEHODS ON POLYOPAL MESHES LIN

More information

On the equivalence of regularity criteria for triangular and tetrahedral finite element partitions

On the equivalence of regularity criteria for triangular and tetrahedral finite element partitions Computers and Mathematics with Applications 55 (2008) 2227 2233 www.elsevier.com/locate/camwa On the equivalence of regularity criteria for triangular and tetrahedral finite element partitions Jan Brandts

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

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

SPECTRAL PROPERTIES OF THE LAPLACIAN ON BOUNDED DOMAINS

SPECTRAL PROPERTIES OF THE LAPLACIAN ON BOUNDED DOMAINS SPECTRAL PROPERTIES OF THE LAPLACIAN ON BOUNDED DOMAINS TSOGTGEREL GANTUMUR Abstract. After establishing discrete spectra for a large class of elliptic operators, we present some fundamental spectral properties

More information

SUPERCONVERGENCE PROPERTIES FOR OPTIMAL CONTROL PROBLEMS DISCRETIZED BY PIECEWISE LINEAR AND DISCONTINUOUS FUNCTIONS

SUPERCONVERGENCE PROPERTIES FOR OPTIMAL CONTROL PROBLEMS DISCRETIZED BY PIECEWISE LINEAR AND DISCONTINUOUS FUNCTIONS SUPERCONVERGENCE PROPERTIES FOR OPTIMAL CONTROL PROBLEMS DISCRETIZED BY PIECEWISE LINEAR AND DISCONTINUOUS FUNCTIONS A. RÖSCH AND R. SIMON Abstract. An optimal control problem for an elliptic equation

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

1. Subspaces A subset M of Hilbert space H is a subspace of it is closed under the operation of forming linear combinations;i.e.,

1. Subspaces A subset M of Hilbert space H is a subspace of it is closed under the operation of forming linear combinations;i.e., Abstract Hilbert Space Results We have learned a little about the Hilbert spaces L U and and we have at least defined H 1 U and the scale of Hilbert spaces H p U. Now we are going to develop additional

More information

Weak Convergence Methods for Energy Minimization

Weak Convergence Methods for Energy Minimization Weak Convergence Methods for Energy Minimization Bo Li Department of Mathematics University of California, San Diego E-mail: bli@math.ucsd.edu June 3, 2007 Introduction This compact set of notes present

More information

NUMERICAL PARTIAL DIFFERENTIAL EQUATIONS

NUMERICAL PARTIAL DIFFERENTIAL EQUATIONS NUMERICAL PARTIAL DIFFERENTIAL EQUATIONS Lecture Notes, Winter 2011/12 Christian Clason January 31, 2012 Institute for Mathematics and Scientific Computing Karl-Franzens-Universität Graz CONTENTS I BACKGROUND

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

HIGHER ORDER FINITE-ELEMENT MODELLING FOR CURVED INTERFACE PROBLEMS BASED ON STRAIGHT- EDGED N-SIMPLEXES AND POLYNOMIAL ALGEBRA

HIGHER ORDER FINITE-ELEMENT MODELLING FOR CURVED INTERFACE PROBLEMS BASED ON STRAIGHT- EDGED N-SIMPLEXES AND POLYNOMIAL ALGEBRA 6th European Conference on Computational Mechanics (ECCM 6) 7th European Conference on Computational Fluid Dynamics (ECFD 7) 1115 June 2018, Glasgow, UK HIGHER ORDER FINITE-ELEMENT MODELLING FOR CURVED

More information

The following definition is fundamental.

The following definition is fundamental. 1. Some Basics from Linear Algebra With these notes, I will try and clarify certain topics that I only quickly mention in class. First and foremost, I will assume that you are familiar with many basic

More information

2. Dual space is essential for the concept of gradient which, in turn, leads to the variational analysis of Lagrange multipliers.

2. Dual space is essential for the concept of gradient which, in turn, leads to the variational analysis of Lagrange multipliers. Chapter 3 Duality in Banach Space Modern optimization theory largely centers around the interplay of a normed vector space and its corresponding dual. The notion of duality is important for the following

More information

Lecture Notes 1: Vector spaces

Lecture Notes 1: Vector spaces Optimization-based data analysis Fall 2017 Lecture Notes 1: Vector spaces In this chapter we review certain basic concepts of linear algebra, highlighting their application to signal processing. 1 Vector

More information

arxiv: v1 [math.na] 29 Feb 2016

arxiv: v1 [math.na] 29 Feb 2016 EFFECTIVE IMPLEMENTATION OF THE WEAK GALERKIN FINITE ELEMENT METHODS FOR THE BIHARMONIC EQUATION LIN MU, JUNPING WANG, AND XIU YE Abstract. arxiv:1602.08817v1 [math.na] 29 Feb 2016 The weak Galerkin (WG)

More information

Numerical Analysis and Methods for PDE I

Numerical Analysis and Methods for PDE I Numerical Analysis and Methods for PDE I A. J. Meir Department of Mathematics and Statistics Auburn University US-Africa Advanced Study Institute on Analysis, Dynamical Systems, and Mathematical Modeling

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

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

Functional Analysis. Franck Sueur Metric spaces Definitions Completeness Compactness Separability...

Functional Analysis. Franck Sueur Metric spaces Definitions Completeness Compactness Separability... Functional Analysis Franck Sueur 2018-2019 Contents 1 Metric spaces 1 1.1 Definitions........................................ 1 1.2 Completeness...................................... 3 1.3 Compactness......................................

More information

One-dimensional and nonlinear problems

One-dimensional and nonlinear problems Solving PDE s with FEniCS One-dimensional and nonlinear problems L. Ridgway Scott The Institute for Biophysical Dynamics, The Computation Institute, and the Departments of Computer Science and Mathematics,

More information

Weak Formulation of Elliptic BVP s

Weak Formulation of Elliptic BVP s Weak Formulation of Elliptic BVP s There are a large number of problems of physical interest that can be formulated in the abstract setting in which the Lax-Milgram lemma is applied to an equation expressed

More information

Nodal O(h 4 )-superconvergence of piecewise trilinear FE approximations

Nodal O(h 4 )-superconvergence of piecewise trilinear FE approximations Preprint, Institute of Mathematics, AS CR, Prague. 2007-12-12 INSTITTE of MATHEMATICS Academy of Sciences Czech Republic Nodal O(h 4 )-superconvergence of piecewise trilinear FE approximations Antti Hannukainen

More information

The Mortar Boundary Element Method

The Mortar Boundary Element Method The Mortar Boundary Element Method A Thesis submitted for the degree of Doctor of Philosophy by Martin Healey School of Information Systems, Computing and Mathematics Brunel University March 2010 Abstract

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

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

Existence of minimizers for the pure displacement problem in nonlinear elasticity

Existence of minimizers for the pure displacement problem in nonlinear elasticity Existence of minimizers for the pure displacement problem in nonlinear elasticity Cristinel Mardare Université Pierre et Marie Curie - Paris 6, Laboratoire Jacques-Louis Lions, Paris, F-75005 France Abstract

More information

Numerische Mathematik

Numerische Mathematik Numer. Math. (2012) 122:61 99 DOI 10.1007/s00211-012-0456-x Numerische Mathematik C 0 elements for generalized indefinite Maxwell equations Huoyuan Duan Ping Lin Roger C. E. Tan Received: 31 July 2010

More information

arxiv: v1 [math.na] 27 Jan 2016

arxiv: v1 [math.na] 27 Jan 2016 Virtual Element Method for fourth order problems: L 2 estimates Claudia Chinosi a, L. Donatella Marini b arxiv:1601.07484v1 [math.na] 27 Jan 2016 a Dipartimento di Scienze e Innovazione Tecnologica, Università

More information

Variational Principles for Equilibrium Physical Systems

Variational Principles for Equilibrium Physical Systems Variational Principles for Equilibrium Physical Systems 1. Variational Principles One way of deriving the governing equations for a physical system is the express the relevant conservation statements and

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

Adaptive Finite Element Methods Lecture Notes Winter Term 2017/18. R. Verfürth. Fakultät für Mathematik, Ruhr-Universität Bochum

Adaptive Finite Element Methods Lecture Notes Winter Term 2017/18. R. Verfürth. Fakultät für Mathematik, Ruhr-Universität Bochum Adaptive Finite Element Methods Lecture Notes Winter Term 2017/18 R. Verfürth Fakultät für Mathematik, Ruhr-Universität Bochum Contents Chapter I. Introduction 7 I.1. Motivation 7 I.2. Sobolev and finite

More information

Cambridge University Press The Mathematics of Signal Processing Steven B. Damelin and Willard Miller Excerpt More information

Cambridge University Press The Mathematics of Signal Processing Steven B. Damelin and Willard Miller Excerpt More information Introduction Consider a linear system y = Φx where Φ can be taken as an m n matrix acting on Euclidean space or more generally, a linear operator on a Hilbert space. We call the vector x a signal or input,

More information

PARTITION OF UNITY FOR THE STOKES PROBLEM ON NONMATCHING GRIDS

PARTITION OF UNITY FOR THE STOKES PROBLEM ON NONMATCHING GRIDS PARTITION OF UNITY FOR THE STOES PROBLEM ON NONMATCHING GRIDS CONSTANTIN BACUTA AND JINCHAO XU Abstract. We consider the Stokes Problem on a plane polygonal domain Ω R 2. We propose a finite element method

More information

Weak Solutions, Elliptic Problems and Sobolev Spaces

Weak Solutions, Elliptic Problems and Sobolev Spaces 3 Weak Solutions, Elliptic Problems and Sobolev Spaces 3.1 Introduction In Chapter 2 we discussed difference methods for the numerical treatment of partial differential equations. The basic idea of these

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

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

DIFFERENTIAL EQUATIONS

DIFFERENTIAL EQUATIONS NUMERICAL PARTIAL DIFFERENTIAL EQUATIONS Lecture Notes, Winter 2013/14 Christian Clason July 15, 2014 Institute for Mathematics and Scientific Computing Karl-Franzens-Universität Graz CONTENTS I BACKGROUND

More information

LECTURE NOTES ELEMENTARY NUMERICAL METHODS. Eusebius Doedel

LECTURE NOTES ELEMENTARY NUMERICAL METHODS. Eusebius Doedel LECTURE NOTES on ELEMENTARY NUMERICAL METHODS Eusebius Doedel TABLE OF CONTENTS Vector and Matrix Norms 1 Banach Lemma 20 The Numerical Solution of Linear Systems 25 Gauss Elimination 25 Operation Count

More information

WELL POSEDNESS OF PROBLEMS I

WELL POSEDNESS OF PROBLEMS I Finite Element Method 85 WELL POSEDNESS OF PROBLEMS I Consider the following generic problem Lu = f, where L : X Y, u X, f Y and X, Y are two Banach spaces We say that the above problem is well-posed (according

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

Linear Algebra. Session 12

Linear Algebra. Session 12 Linear Algebra. Session 12 Dr. Marco A Roque Sol 08/01/2017 Example 12.1 Find the constant function that is the least squares fit to the following data x 0 1 2 3 f(x) 1 0 1 2 Solution c = 1 c = 0 f (x)

More information

2 Elliptic Differential Equations

2 Elliptic Differential Equations 2 Elliptic Differential Equations 2.1 Classical solutions As far as existence and uniqueness results for classical solutions are concerned, we restrict ourselves to linear elliptic second order elliptic

More information

Traces, extensions and co-normal derivatives for elliptic systems on Lipschitz domains

Traces, extensions and co-normal derivatives for elliptic systems on Lipschitz domains Traces, extensions and co-normal derivatives for elliptic systems on Lipschitz domains Sergey E. Mikhailov Brunel University West London, Department of Mathematics, Uxbridge, UB8 3PH, UK J. Math. Analysis

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

Algorithms for Scientific Computing

Algorithms for Scientific Computing Algorithms for Scientific Computing Finite Element Methods Michael Bader Technical University of Munich Summer 2016 Part I Looking Back: Discrete Models for Heat Transfer and the Poisson Equation Modelling

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

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

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

More information

Auerbach bases and minimal volume sufficient enlargements

Auerbach bases and minimal volume sufficient enlargements Auerbach bases and minimal volume sufficient enlargements M. I. Ostrovskii January, 2009 Abstract. Let B Y denote the unit ball of a normed linear space Y. A symmetric, bounded, closed, convex set A in

More information

Chapter 5. Linear Algebra. A linear (algebraic) equation in. unknowns, x 1, x 2,..., x n, is. an equation of the form

Chapter 5. Linear Algebra. A linear (algebraic) equation in. unknowns, x 1, x 2,..., x n, is. an equation of the form Chapter 5. Linear Algebra A linear (algebraic) equation in n unknowns, x 1, x 2,..., x n, is an equation of the form a 1 x 1 + a 2 x 2 + + a n x n = b where a 1, a 2,..., a n and b are real numbers. 1

More information

Algebraic Methods in Combinatorics

Algebraic Methods in Combinatorics Algebraic Methods in Combinatorics Po-Shen Loh 27 June 2008 1 Warm-up 1. (A result of Bourbaki on finite geometries, from Răzvan) Let X be a finite set, and let F be a family of distinct proper subsets

More information

Fact Sheet Functional Analysis

Fact Sheet Functional Analysis Fact Sheet Functional Analysis Literature: Hackbusch, W.: Theorie und Numerik elliptischer Differentialgleichungen. Teubner, 986. Knabner, P., Angermann, L.: Numerik partieller Differentialgleichungen.

More information

Theory of PDE Homework 2

Theory of PDE Homework 2 Theory of PDE Homework 2 Adrienne Sands April 18, 2017 In the following exercises we assume the coefficients of the various PDE are smooth and satisfy the uniform ellipticity condition. R n is always an

More information