Introduction. J.M. Burgers Center Graduate Course CFD I January Least-Squares Spectral Element Methods

Size: px
Start display at page:

Download "Introduction. J.M. Burgers Center Graduate Course CFD I January Least-Squares Spectral Element Methods"

Transcription

1 Introduction In this workshop we will introduce you to the least-squares spectral element method. As you can see from the lecture notes, this method is a combination of the weak formulation derived from minimizing the residual in the least-squares sense and the approximation by spectral elements. In setting up this workshop we had to decide whether we wanted to let you become familiar with the method in a complex setting non-linear, time-dependent calculations or restrict ourselves to simpler problems, which allows you to get a better understanding of the method. We have chosen for the second line for several reasons: 1) The method is quite new, so it is hard to find references which address the more theoretical issues, and ) The extension to more complicated problems merely requires time and a fair amount of book-keeping). The goal of this workshop is to understand the method by combining theoretical derivations with actual computational results. This workshop has also been given at the Von Karman Institute for Fluid Dynamics in the summer of 006. In this workshop students spend whole days on the subject. In order to retain the balance between theory, programming and analyzing the results as much as possible, for some problems the answers are already provided. This allows you to spend the two hours allocated in this Burgers course to play with the sample programs. The main focus will be on the 1D problem, but the code for the hyperbolic and elliptic D problems are also provided for those interested. If you have any questions during or after this workshop, do not hesitate to contact me M.I.Gerritsma@TUDelft.nl). We hope you have a nice week and look forward to your appraisal. The exercises for this part of the Burgers course are scheduled on Friday 5 January at Marc Gerritsma 1 Bart De Maerschalck

2 1D LSQSEM problem We will use the 1D model problem of the lecture notes to get some practical experience with different forms of least-squares spectral element method. Before we start the exercises we will repeat some theory from the lecture serie. Let us consider a first order scalar ordinary differential equation in the interval [, 1] given by u x) = gx), 1) where u = du/dx and g is a given function. Consider the norm for u u) = 0, ) u L,1) = u x) ) { dx, u U = u L,1) u) = 0 }. 3) Now let us consider all functions for which u H 1,1) := u L,1) + u L,1) <. 4) The set of all these functions obviously forms a linear function space denoted by H 1, 1) where the superscript 1 denotes the highest derivative that must be square integrable. In order to satisfy the boundary conditions we choose the linear subspace Now it is clear that H = { u H 1, 1) u) = 0 }. 5) u L,1) u H 1,1), u H. 6) So the differential operator is bounded continuous in H with constant C = 1. In order to show coercivity we use the Poincaré inequality Therefore ux) = u) + u L,1) = = x u ξ) dξ = x u ξ) dξ, u H. 7) { x u dx = u ξ) dξ} dx { x } u ξ) dξ dx { } u ξ) dξ dx u L,1) dx = u L,1) dx = u L,1). 8) Marc Gerritsma Bart De Maerschalck

3 So u H 1,1) = u L,1) + u L,1) 3 u L,1). 9) Which gives C 1 = 1/3. So we have the desired norm equivalence 1 3 u H 1,1) u L,1) u H 1,1). 10) Now that we have established norm-equivalence for all u H we can insert the function u u ex in which case we obtain 1 3 u uex H 1,1) u u ex ) L,1) = u g L,1) u uex H 1,1). 11) The first inequality in 11) tells us that if we have sequence {u n } n 1 for which in the L -norm, then the error lim n un ) g L,1) = 0 1) lim n un u ex H 1,1) = 0 13) converges in the H 1 -norm. The second inequality in 11) tells us that the norm of the residual is less or equal to the H 1 -norm of the best approximation to u ex in the H 1 -norm. Problem Minimize the L -norm of the residual, given by by means of variational analysis d lim ɛ 0 dɛ u g L = 1 u g) dx 14) d u + ɛv) g dx = 0, v H 15) L Answer u v dx = v g dx, v H The next step is to discretize this formulation. As in finite element methods the domain is divided in N cells subdomains. On each of these subdomains the solutions is approximated by a Lagrange polynomial see the lecture notes for these polynomials) of order P : u h e x) = P +1 j=1 u j h j ξ), 16) with u j the unknown coefficients and for ξ = x x 1 x 1, locale coordinate system, with x 1 the coordinate of the left vortex-node of the element and x denotes the length of the element. Marc Gerritsma 3 Bart De Maerschalck

4 If we substitute 16) into the derived minimization. By choosing v = h i ξ) with 1 i P + 1) the element matrix can be derived. Both the element matrix and the element load vector have already been implemented in the Matlab file mainexercise1.m, which is located in the directort LSSEM_1D. When composing the entries of the element a number of integrals will have to be evaluated. In finite element methods this can be done exactly, however when a spectral approximation is used in general these integrals have to be evaluated numerically. In standard spectral element methods these integrals are evaluated using a Gauss integration: fξ) dξ N+1 i=1 w i fξ i ), 17) with w i the N + 1 Gauss-Lobatto-Legendre weights and ξ i the GLL-roots. Often N = P is chosen, however it is possible, and for some cases necessary, the choose N P keep in mind that 17) is exact when fx) is a polynomial up to order N 1). The Matlab routines gl_rootsn) and gl_weightsn) are available to calculate the GLL-roots and weights. If you would need to calculate the value of the basis functions hξ) or the derivative of the first derivative in a certain node the functions derivativematrices1d.m and derivativematricesrandomnodes1d.m will be useful. Problem Implement the parts of the code where you calculate numerically) the L - norm of the error and the L -norm of the residual Problem Implement also the H 1 -norm of the error and verify the a priori estimate 11). Problem Test your program by inserting a polynomial exact solution. Both the error and the residual should be zero when the polynomial degree in the approximation is chosen sufficiently high A numerical method is called optimal when the highest possible convergence rate is attained. The convergence rate cannot exceed the convergence rate obtained by direct interpolation of the exact solution, otherwise our numerical method would approximate the exact solution faster. Let us therefore establish the convergence rate of interpolation of the exact solution. Marc Gerritsma 4 Bart De Maerschalck

5 Problem Assume that the exact solution is square integrable over the interval [, 1]. Then the exact solution can be written as u ex x) = α i L i x), x [, 1], i=0 where L i x) is the ith Legendre polynomial and α i is called the Legendre coefficient. Assume that we want to approximate this function with a finite dimensional representation of the form N u N x) = α i L i x), x [, 1]. i=0 Show that the finite dimensional approximation which minimizes the L -norm of the error u ex u N L [,1] is given by α i = α i, for i = 0,..., N. Hint: make use of the fact that the Legendre polynomials are orthogonal over the interval [, 1], i.e. L i x)l j x) dx = i + 1 δ ij, where δ ij is the Kronecker delta defined by 1 if i = j δ ij = 0 if i j Answer The error is given by u ex u N = β i L i = i=0 N α i α i ) L i + α i L i. i=0 i=n+1 So β i = α i α i for i = 0,..., N and β i = α i for i = N + 1,..., Now taking the L -norm of this error gives u ex u N = = = = i=0 β i L i β j L j dx j=0 β i β j L i L j dx i=0 i=0 N i=0 β i j=0 i + 1 i + 1 α i α i ) + i=n+1 i + 1 α i. Now the α i s are given, so the only degrees of freedom we have to minimize the error are the α i s and we readily see that by taking α i = α i the L -norm of the error is minimized. Marc Gerritsma 5 Bart De Maerschalck

6 So the error for th optimal L approximation is given by u ex u N = i=n+1 i + 1 α i. Now assume that the exact solution is a member of the Sobolev space H k, 1) the function is square integrable and all its derivatives up to the k-th derivative are square integrable) then the error can bounded by u ex u N = i=n+1 i s)! i + s)! i + 1 i + s)! i s)! α i where s = minn + 1, k). Now we use the fact that u ex Hw,1) s = 1 x ) d s u ex ) dx s dx = This allows us to bound the interpolation error as u ex u N N + 1 s)! N s)! i=n+1 N + 1 s)! N s)! uex H s w,1). i=n+1 i + s)! i + 1 i s)! α i, i + s)! i + 1 i s)! α i. If the exact solution is very smooth, i.e. k very large, we have that s = N + 1, so u ex u N 1 N + )! uex H N+1 w,1). Problem Use the error estimate u ex u N L,1) in terms of uex to derive Hw N+1,1) the error over an arbitrary interval [a, b] and show that for a fixed polynomial degree N, the error converges as u ex u N L a,b) = O b a) N+1). Marc Gerritsma 6 Bart De Maerschalck

7 Answer Let ξ = x a + b) b a, = dξ = b a dx, d dξ = b a d dx. So we have that Furthermore we have, and therefore u ex u N L a,b) = Combining these results gives Therefore = b a u ex x) u N x) ) dx u ex ξ) u N ξ) ) b a = b a uex u N L,1). d N+1 u ex ) N+1 d N+1 u ex dx N+1 = b a dξ N+1, ) N+1 u ex Hw N+1 a,b) = u ex b a Hw N+1,1). u ex u N L a,b) = b a uex u N L,1) b a 1 N + )! uex Hw N+1,1) = b a ) b a N+1 1 dξ N + )! uex Hw N+1 a,b) ) b a N+1 u ex u N 1 L a,b) N + )! uex H N+1 w a,b) = O b a) N+1). Problem Perform convergence studies to establish the convergence rate of the LSQSEM method that you have implemented. Does it make a difference whether you use polynomials of odd degree or even degree. Is LSQSEM optimal for this problem? Problem Try different right hand side functions and associated exact solutions to see how the method responds to this change. Try for instance, the exact solution e κx e κ e κ e κ, κ > 0. Marc Gerritsma 7 Bart De Maerschalck

8 What happens if κ is chosen sufficiently large? For instance κ = 100. Perform a convergence study in which you play with the number of elements and the polynomial degree. Do you see wiggles? Do the wiggles pollute the whole domain? Problem Perform a similar convergence study using the spectral Galerkin method. How do you need to modify the code to convert it to a Galerkin Method NB Also change the solver!). Does it make a difference whether you use polynomials of odd degree or even degree. Is the Galerkin method optimal for this problem? Derivation of the LSQSEM for the Poisson equation Having analyzed the 1D model problem we now turn to a two-dimensional problem. The Poisson equation we wish to consider in this workshop is given by with φ = f, for x Ω, 18) φ = g, for x Ω. 19) n Here Ω R is a bounded not necessarily simply-connected domain with boundary Ω. n is the outward unit normal to Ω. The functions f and g L Ω) are given. We need to solve this problem for the unknown function φ, which we will refer from now on to as the potential. Although the Poisson equation plays an important role in many branches of physics, we will mainly interpret this equation as the equation describing an incompressible, irrotational, inviscid flow in the absence of body forces. The velocity field generated by such a potential flow is given by u = φ u = φ x, v = φ y. 0) Problem Rewrite the Poisson problem as a first order system of equations and write down the norm of the residuals in the L norm. For which functions do these norms make sense? Marc Gerritsma 8 Bart De Maerschalck

9 Answer First order system u x + v y = f, u = φ x, v = φ y. Physically the first equation expresses conservation of mass for an incompressible flow and the remaining equation define the velocity field. The L -norm of the residuals is given by u x + v y f + u φ x + v φ y. These equations only make sense if u L, v L, u L and φ L. Note that we do not require that u/ x and v/ y separately belong to L!! Note that for an irrotational flow we have that the vorticity is zero. ξ = v/ x u/ y, Problem Why don t we add the condition that the flow is irrotational? Answer The fact that we derive the velocity field from a potential function guarantees that the resulting flow field is irrotational v x u y = φ x y φ y x 0. Alternatively, we can also employ the conventional Galerkin method to solve the Poisson equation. An advantage of this approach is that we do not need to convert the second order differential equation to an equivalent first order system. Having solved 18) for φ allows one obtain the velocity components in a post-processing step. In general the accuracy of these derived quantities is one order lower than the order of accuracy of the primal variable φ. Additionally, the derived quantities are in general not continuous across element boundaries. Problem Write down the weak formulation for the Poisson problem using the Galerkin method without introducing auxiliary variables. For what functions φ does this formulation makes sense? Argue that continuity of φ across element boundaries is sufficient to have a conforming approximation. Marc Gerritsma 9 Bart De Maerschalck

10 Answer Multiply the Poisson equation with an arbitrary test function ψ and apply integration by parts φ ) 0 = φ f) ψ dω = Ω Ω n ψ ds φ, ψ dω fψ dω. Ω Ω These integrals make sense if φ, ψ H 1 Ω) and f L Ω). Discontinuities are square integrable, but the derivative of discontinuities Dirac delta distributions are not square integrable, therefore we do not allow discontinuities in this formulation. This implies, that for a conforming method, the solution between elements needs to be continuous. The derived quantities, such as a velocity field, will then in general be discontinuous between elements. If we first rewrite the Poisson equation as a first order system and then we apply the Galerkin method, we obtain a so-called mixed method. If we follow this approach, we start with the first order system u φ = 0, in Ω, 1) and u = f, in Ω. ) Now multiplying 1) by v W and integrating, and multiplying ) by ψ H and integrating by parts, we obtain the mixed Galerkin formulation. Here W and H are admissible function spaces to be determined. ) u, v) φ, v = 0, v W, 3) ) ψ, u = f, ψ). 4) For convenience we assume homogeneous boundary conditions. The mixed Galerkin method produces a saddle-point variational problem and therefore existence and uniqueness require that the function spaces W and H satisfy the LBB condition given by Ω φ sup u dω 0 φ H Ω φ ) 1/ γ u L Ω), u W, dω where γ > 0. This condition puts restrictions on the function spaces that can be used. If incompatible function spaces are used, the method may not produce sensible results. If appropriate function spaces are used, and we assume that φ, u) H r+1 Ω) [H r Ω)] d then we have the following error estimate φ φ h 1 + u u h 0 Ch r φ r+1 + u r ). So even for a compatible approximation, the approximation of the velocity field is always one order lower than the approximation of the potential. Inspecting the mixed Galerkin formulation we also see that the method is non-positive definite. This hinders the use of iterative solution techniques. Let us return to the least-squares formulation. Marc Gerritsma 10 Bart De Maerschalck

11 Problem We have derived the L -norm of the residual of the first order system. In order to find the solution which minimizes the norm of the residuals, we need to apply variational analysis to obtain the weak least-squares formulation. Assume that the sum of the squared residuals is given by J φ, u, v), then variational analysis gives the three equations J φ + ɛψ, u, v) ɛ = 0, ψ W, ɛ=0 J φ, u + ɛũ, v) ɛ = 0, ũ U, ɛ=0 and J φ, u, v + ɛṽ) ɛ = 0, ṽ V. ɛ=0 Explicitly derive the weak least-squares formulation. Answer Applying the above recipe to the φ gives u φ x, ψ ) + v φ x y, ψ ) y and to u and finally to v = 0, ψ W, u x + v ) ũ f, + u φ ) y x x, ũ = 0, ũ U, u x + v ) ṽ f, + v φ ) y y y, ṽ = 0, ṽ V, Problem Show that the weak system you have derived by requiring that the total residual is minimized, is symmetric Answer By taking a linear combination of the above equations we have u φ x, ũ ψ ) + v φ x y, ṽ ψ ) u + y x + v ũ f, y x + ṽ ) y ψ W, ũ U and ṽ V. = 0, Here we see that interchanging the trial functions φ, u and v with the test functions ψ, ũ and ṽ leaves the formulation unaltered, thus showing that the formulation is symmetric. Having derived a symmetric formulation, we still do not know whether minimization of the residuals actually means that the error with respect to the exact solution also decreases. In order to show this, we need to derive the a priori estimates which relate the L -norm of the residuals to the error-norm. Marc Gerritsma 11 Bart De Maerschalck

12 Problem and Define the following function spaces { H 1 Ω) = φ L Ω) and φ [ L Ω) ] }, 5) Hdiv, Ω) = { u [ L Ω) ] } and u L Ω). 6) The associated norms are defined by [ φ H 1 Ω) = φ + and Ω u Hdiv,Ω) = Ω [ ) φ + x u + v + ) ] φ dω, 7) y u x + v ) ] dω. 8) y Show that the sum of the residuals squared is bounded from above by the φ H 1 Ω) + u Hdiv,Ω). Answer The sum of the residuals squared is given by u x + v y + u φ x + v φ y = u + u + v + φ u, φ x ) v, φ y Now use the fact 0 a + b) which implies that ab a + b. This inequality allows us to bound u, φ ) u + φ x x, and Combining gives ) v, φ ) v + φ y y. u x + v y + u φ x + v φ y u + u + φ. Now using that φ φ H 1 Ω) and u + u = u Hdiv,Ω) we obtain u x + v y + u φ x + v φ [ ] y φ H 1 Ω) + u Hdiv,Ω) This demonstrates that the residuals are bounded in the norm of unknowns.. This estimate can be interpreted in several ways. First, for all functions φ and u which are measurable in the norms given, the residuals are finite as well. If the right hand side of this inequality produces a finite value which is another way that of saying that these functions are members of the associated spaces the residuals are finite as well. Marc Gerritsma 1 Bart De Maerschalck

13 A second implication is that if the error in the associated norms goes to zero, the residuals must go to zero as well. The last interpretation can be stated as follows: Let W be the space of all functions for which the sum of the residuals yields a finite value and let V be the space of all functions for which φ H 1 Ω) + u is finite. Then the inequality you just derived stated Hdiv,Ω) that W V. We now want to derive the reverse, namely that V W and that when the norm of the residuals goes to zero, the error goes to zero as well. Problem The other estimate coercivity is usually harder to establish, so let me guide you through the steps involved: Show that v L + ) ψ v L C ψ L + v L + v, ψ Hints: Use the following estimates f = f, f), where the inner-product of functions f, g) is defined as f, g) = fx)gx) dω. Ω. 9) Use integration by parts to derive 9). Also use the Friedrichs inequality which states that on a bounded domain Ω for φ H 1 Ω) with φ = 0 at the boundary Ω we have φ L Ω) C φ L Ω). 30) Restrict therefore your attention to homogeneous problems where ψ = 0 at the boundary. Is this a restriction?) Answer Using the Hints we have v + v ψ v ψ ) = v + ψ v, ψ = v + ψ ) + v, ψ ) v + C ψ + v, ψ integration by parts Friedrichs inequality Furthermore we have that and therefore also for C > 0 1 C v + u ψ v, 31) [ v + u ψ ] 1 C v. 3) Marc Gerritsma 13 Bart De Maerschalck

14 If we combine this estimate with 9) we have that ) [ C v + u ψ ] 1 ) C v + v + C ψ + v, ψ = 1 v + Cψ + v C v 33) Problem Every norm should satisfy the triangle inequality a + b a + b. Use the triangle inequality, 33) and the fact that v + u ψ u ψ, to show that there exists a constant C such that [ C v + u ψ ] ψ. 34) Answer v + u ψ u ψ = v + u ψ u ψ. Furthermore, we have from 33) that where C 1 = 1 + 1/C. Therefore we have Now use the fact that C 1 v + u ψ v, 1 + C 1 ) v + u ψ u ψ + v. ψ = ψ = v ψ + v v ψ + v. Here we use the triangle inequality with a = v ψ and b = v. Now using the Friedrichs inequality again we have that C [ v + u ψ ] ψ. 35) Problem Use 31), 33), 34) and 35) to show coercivity in the spaces ψ H 1 Ω) and v Hdiv, Ω) Marc Gerritsma 14 Bart De Maerschalck

15 Answer Combining the four aforementioned estimates gives v + u ψ [ C 3 u + v + ψ + ψ ] ] = C 3 [ v Hdiv,Ω) + ψ H 1 Ω). 36) This coercivity result implies that if the L -norm of the residual goes to zero, the error in φ converges in the H 1 -norm and the error in the velocity converges in the Hdiv)-norm. The Hdiv)-norm is a weaker norm than the H 1 -norm. When we are going to play with this method, you will see what the implications of this weaker norm are. The coercivity result also states that the space of all functions W for which the residuals are defined contains the space of functions V = H 1 Ω) Hdiv, Ω). So, we have shown now that the both spaces, W and V contain the same functions, which essentially means that both spaces are equivalent. Moreover, the two inequalities that we derived can be combined as ] C 1 [ v Hdiv,Ω) + ψ H 1 Ω) v + u ψ [ ] C v Hdiv,Ω) + ψ H 1 Ω). 37) Problem Implement the least-squares formulation in the sample program that will be provided. Select a function φx, y) and compute the associated right hand side vector f. Also compute manually the velocity components u and v. Check your implementation by choosing for φ a polynomial solution in x and y. This allows you to heck whether for a given polynomial degree of the approximating function space both the residual norm and the error norm become zero. Then choose a more exotic function φ and perform a similar convergence analysis as was done for the 1D problem, i.e. h-convergence and p-convergence. Plot φ h φ ex L, u h u ex L, v h v ex L and the norm of the residuals as a function of the mesh-size h and as a function of the polynomial degree p. Answer φ converges optimally with h-refinement, i.e. the convergence rate will be h P +1, if P is the polynomial degree used for the spectral elements. u and v will converge sub-optimal, i.e. the convergence rate will be h α, with α < P + 1. With p refinement exponential convergence should result in all error norms. Optimal LSQSEM In the previous section is what argued that adding the equation for an irrotational flow v x u y = 0, is superfluous. However, numerically it may make a difference. Marc Gerritsma 15 Bart De Maerschalck

16 Problem Add the irrotationality condition to your discrete system in the LSQSEM program. Perform again the convergence studies. How does the addition of this extra equation affect the error norms for φ, u and v? Answer All variables converge optimally with h-refinement, i.e. the convergence rate will be h P +1, if P is the polynomial degree used for the spectral elements. With p refinement exponential convergence should result in all error norms. In many practical problems where we encounter Poisson problems we are not so much interested in the potential φ, but more in the φ. We have seen that the optimal least-squares method converges optimally for these variables of interest. This cannot be achieved with the Galerkin or finite difference/finite volume methods. Furthermore, the velocity field produced by the optimal least-squares method is continuous, so we do not have multi-valued solutions at element boundaries. And finally, we do not need to bother about compatible function space as expressed by the LBB condition. These features make the LSQSEM formulation an interesting alternative to existing discretization methods. And then... You have had some experience with the least-squares spectral element method. The main building block is the norm equivalence between the residual norm and the error in suitable norms. For many equations of interest such a priori estimates can be found in the literature. An important tool in deriving such error estimates is the so-called ADN theory for elliptic systems. However, much needs to be done on the mathematical justification of the method. If we do not have a priori estimates all we can do is hope for the best. Suppose there exists exotic norms for which norm-equivalence can be established. Then use you favorite leastsquares discretization and remember that at the discrete level all norms are equivalent. So even if you do not have a formulation in the appropriate norms, you will still get reasonable results with your method of choice. However, optimal convergence cannot be guaranteed in that case... We hope you enjoyed this workshop. Hopefully, the techniques presented inspire you to use LSQSEM, or at least borrow some of its tricks to improve your work. Additional information can found in the references at the end of the lecture notes Marc Gerritsma 16 Bart De Maerschalck

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

hp-adaptive least squares spectral element method for hyperbolic partial differential equations

hp-adaptive least squares spectral element method for hyperbolic partial differential equations Journal of Computational and Applied Mathematics 215 (2008) 409 418 www.elsevier.com/locate/cam hp-adaptive least squares spectral element method for hyperbolic partial differential equations Árpád Galvão

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

ACM/CMS 107 Linear Analysis & Applications Fall 2017 Assignment 2: PDEs and Finite Element Methods Due: 7th November 2017

ACM/CMS 107 Linear Analysis & Applications Fall 2017 Assignment 2: PDEs and Finite Element Methods Due: 7th November 2017 ACM/CMS 17 Linear Analysis & Applications Fall 217 Assignment 2: PDEs and Finite Element Methods Due: 7th November 217 For this assignment the following MATLAB code will be required: Introduction http://wwwmdunloporg/cms17/assignment2zip

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

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

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

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

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

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

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

More information

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

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

More information

Vectors in Function Spaces

Vectors in Function Spaces Jim Lambers MAT 66 Spring Semester 15-16 Lecture 18 Notes These notes correspond to Section 6.3 in the text. Vectors in Function Spaces We begin with some necessary terminology. A vector space V, also

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

Linear Algebra Massoud Malek

Linear Algebra Massoud Malek CSUEB Linear Algebra Massoud Malek Inner Product and Normed Space In all that follows, the n n identity matrix is denoted by I n, the n n zero matrix by Z n, and the zero vector by θ n An inner product

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

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

MA2501 Numerical Methods Spring 2015

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

More information

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

Vector Spaces. Vector space, ν, over the field of complex numbers, C, is a set of elements a, b,..., satisfying the following axioms.

Vector Spaces. Vector space, ν, over the field of complex numbers, C, is a set of elements a, b,..., satisfying the following axioms. Vector Spaces Vector space, ν, over the field of complex numbers, C, is a set of elements a, b,..., satisfying the following axioms. For each two vectors a, b ν there exists a summation procedure: a +

More information

The method of lines (MOL) for the diffusion equation

The method of lines (MOL) for the diffusion equation Chapter 1 The method of lines (MOL) for the diffusion equation The method of lines refers to an approximation of one or more partial differential equations with ordinary differential equations in just

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

Hilbert Spaces. Hilbert space is a vector space with some extra structure. We start with formal (axiomatic) definition of a vector space.

Hilbert Spaces. Hilbert space is a vector space with some extra structure. We start with formal (axiomatic) definition of a vector space. Hilbert Spaces Hilbert space is a vector space with some extra structure. We start with formal (axiomatic) definition of a vector space. Vector Space. Vector space, ν, over the field of complex numbers,

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

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

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

Weighted Residual Methods

Weighted Residual Methods Weighted Residual Methods Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Table of Contents Problem definition. oundary-value Problem..................

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

A DELTA-REGULARIZATION FINITE ELEMENT METHOD FOR A DOUBLE CURL PROBLEM WITH DIVERGENCE-FREE CONSTRAINT

A DELTA-REGULARIZATION FINITE ELEMENT METHOD FOR A DOUBLE CURL PROBLEM WITH DIVERGENCE-FREE CONSTRAINT A DELTA-REGULARIZATION FINITE ELEMENT METHOD FOR A DOUBLE CURL PROBLEM WITH DIVERGENCE-FREE CONSTRAINT HUOYUAN DUAN, SHA LI, ROGER C. E. TAN, AND WEIYING ZHENG Abstract. To deal with the divergence-free

More information

Physics 342 Lecture 2. Linear Algebra I. Lecture 2. Physics 342 Quantum Mechanics I

Physics 342 Lecture 2. Linear Algebra I. Lecture 2. Physics 342 Quantum Mechanics I Physics 342 Lecture 2 Linear Algebra I Lecture 2 Physics 342 Quantum Mechanics I Wednesday, January 27th, 21 From separation of variables, we move to linear algebra Roughly speaking, this is the study

More information

Multigrid Methods for Saddle Point Problems

Multigrid Methods for Saddle Point Problems Multigrid Methods for Saddle Point Problems Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University Advances in Mathematics of Finite Elements (In

More information

Local pointwise a posteriori gradient error bounds for the Stokes equations. Stig Larsson. Heraklion, September 19, 2011 Joint work with A.

Local pointwise a posteriori gradient error bounds for the Stokes equations. Stig Larsson. Heraklion, September 19, 2011 Joint work with A. Local pointwise a posteriori gradient error bounds for the Stokes equations Stig Larsson Department of Mathematical Sciences Chalmers University of Technology and University of Gothenburg Heraklion, September

More information

We have to prove now that (3.38) defines an orthonormal wavelet. It belongs to W 0 by Lemma and (3.55) with j = 1. We can write any f W 1 as

We have to prove now that (3.38) defines an orthonormal wavelet. It belongs to W 0 by Lemma and (3.55) with j = 1. We can write any f W 1 as 88 CHAPTER 3. WAVELETS AND APPLICATIONS We have to prove now that (3.38) defines an orthonormal wavelet. It belongs to W 0 by Lemma 3..7 and (3.55) with j =. We can write any f W as (3.58) f(ξ) = p(2ξ)ν(2ξ)

More information

Laplace s Equation. Chapter Mean Value Formulas

Laplace s Equation. Chapter Mean Value Formulas Chapter 1 Laplace s Equation Let be an open set in R n. A function u C 2 () is called harmonic in if it satisfies Laplace s equation n (1.1) u := D ii u = 0 in. i=1 A function u C 2 () is called subharmonic

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

Applied Math Qualifying Exam 11 October Instructions: Work 2 out of 3 problems in each of the 3 parts for a total of 6 problems.

Applied Math Qualifying Exam 11 October Instructions: Work 2 out of 3 problems in each of the 3 parts for a total of 6 problems. Printed Name: Signature: Applied Math Qualifying Exam 11 October 2014 Instructions: Work 2 out of 3 problems in each of the 3 parts for a total of 6 problems. 2 Part 1 (1) Let Ω be an open subset of R

More information

Trefftz-discontinuous Galerkin methods for time-harmonic wave problems

Trefftz-discontinuous Galerkin methods for time-harmonic wave problems Trefftz-discontinuous Galerkin methods for time-harmonic wave problems Ilaria Perugia Dipartimento di Matematica - Università di Pavia (Italy) http://www-dimat.unipv.it/perugia Joint work with Ralf Hiptmair,

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

Preliminary Examination in Numerical Analysis

Preliminary Examination in Numerical Analysis Department of Applied Mathematics Preliminary Examination in Numerical Analysis August 7, 06, 0 am pm. Submit solutions to four (and no more) of the following six problems. Show all your work, and justify

More information

Physics 342 Lecture 2. Linear Algebra I. Lecture 2. Physics 342 Quantum Mechanics I

Physics 342 Lecture 2. Linear Algebra I. Lecture 2. Physics 342 Quantum Mechanics I Physics 342 Lecture 2 Linear Algebra I Lecture 2 Physics 342 Quantum Mechanics I Wednesday, January 3th, 28 From separation of variables, we move to linear algebra Roughly speaking, this is the study of

More information

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

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

More information

A Posteriori Error Bounds for Meshless Methods

A Posteriori Error Bounds for Meshless Methods A Posteriori Error Bounds for Meshless Methods Abstract R. Schaback, Göttingen 1 We show how to provide safe a posteriori error bounds for numerical solutions of well-posed operator equations using kernel

More information

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

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

More information

Numerical Methods for Partial Differential Equations

Numerical Methods for Partial Differential Equations Numerical Methods for Partial Differential Equations CAAM 45 Spring 005 Lecture 15 Instructor: Tim Warburton Two-Dimensional Advection Recall in one-dimensions we chose an arbitrary section of a pipe.

More information

Math 341 Summer 2016 Midterm Exam 2 Solutions. 1. Complete the definitions of the following words or phrases:

Math 341 Summer 2016 Midterm Exam 2 Solutions. 1. Complete the definitions of the following words or phrases: Math 34 Summer 06 Midterm Exam Solutions. Complete the definitions of the following words or phrases: (a) A sequence (a n ) is called a Cauchy sequence if and only if for every ɛ > 0, there exists and

More information

Name: INSERT YOUR NAME HERE. Due to dropbox by 6pm PDT, Wednesday, December 14, 2011

Name: INSERT YOUR NAME HERE. Due to dropbox by 6pm PDT, Wednesday, December 14, 2011 AMath 584 Name: INSERT YOUR NAME HERE Take-home Final UWNetID: INSERT YOUR NETID Due to dropbox by 6pm PDT, Wednesday, December 14, 2011 The main part of the assignment (Problems 1 3) is worth 80 points.

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

Numerical Solutions to Partial Differential Equations

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

More information

Overlapping Schwarz preconditioners for Fekete spectral elements

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

More information

A Multigrid Method for Two Dimensional Maxwell Interface Problems

A Multigrid Method for Two Dimensional Maxwell Interface Problems A Multigrid Method for Two Dimensional Maxwell Interface Problems Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University USA JSA 2013 Outline A

More information

We denote the space of distributions on Ω by D ( Ω) 2.

We denote the space of distributions on Ω by D ( Ω) 2. Sep. 1 0, 008 Distributions Distributions are generalized functions. Some familiarity with the theory of distributions helps understanding of various function spaces which play important roles in the study

More information

An Introduction to Numerical Methods for Differential Equations. Janet Peterson

An Introduction to Numerical Methods for Differential Equations. Janet Peterson An Introduction to Numerical Methods for Differential Equations Janet Peterson Fall 2015 2 Chapter 1 Introduction Differential equations arise in many disciplines such as engineering, mathematics, sciences

More information

Fourier Transform & Sobolev Spaces

Fourier Transform & Sobolev Spaces Fourier Transform & Sobolev Spaces Michael Reiter, Arthur Schuster Summer Term 2008 Abstract We introduce the concept of weak derivative that allows us to define new interesting Hilbert spaces the Sobolev

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

An introduction to the mathematical theory of finite elements

An introduction to the mathematical theory of finite elements Master in Seismic Engineering E.T.S.I. Industriales (U.P.M.) Discretization Methods in Engineering An introduction to the mathematical theory of finite elements Ignacio Romero ignacio.romero@upm.es October

More information

AMS subject classifications. Primary, 65N15, 65N30, 76D07; Secondary, 35B45, 35J50

AMS subject classifications. Primary, 65N15, 65N30, 76D07; Secondary, 35B45, 35J50 A SIMPLE FINITE ELEMENT METHOD FOR THE STOKES EQUATIONS LIN MU AND XIU YE Abstract. The goal of this paper is to introduce a simple finite element method to solve the Stokes equations. This method is in

More information

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

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

More information

Robust Domain Decomposition Preconditioners for Abstract Symmetric Positive Definite Bilinear Forms

Robust Domain Decomposition Preconditioners for Abstract Symmetric Positive Definite Bilinear Forms www.oeaw.ac.at Robust Domain Decomposition Preconditioners for Abstract Symmetric Positive Definite Bilinear Forms Y. Efendiev, J. Galvis, R. Lazarov, J. Willems RICAM-Report 2011-05 www.ricam.oeaw.ac.at

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

Basic Principles of Weak Galerkin Finite Element Methods for PDEs

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

More information

LECTURE 16 GAUSS QUADRATURE In general for Newton-Cotes (equispaced interpolation points/ data points/ integration points/ nodes).

LECTURE 16 GAUSS QUADRATURE In general for Newton-Cotes (equispaced interpolation points/ data points/ integration points/ nodes). CE 025 - Lecture 6 LECTURE 6 GAUSS QUADRATURE In general for ewton-cotes (equispaced interpolation points/ data points/ integration points/ nodes). x E x S fx dx hw' o f o + w' f + + w' f + E 84 f 0 f

More information

Mixed Finite Elements Method

Mixed Finite Elements Method Mixed Finite Elements Method A. Ratnani 34, E. Sonnendrücker 34 3 Max-Planck Institut für Plasmaphysik, Garching, Germany 4 Technische Universität München, Garching, Germany Contents Introduction 2. Notations.....................................

More information

Math 342 Partial Differential Equations «Viktor Grigoryan

Math 342 Partial Differential Equations «Viktor Grigoryan Math 342 Partial Differential Equations «Viktor Grigoryan 15 Heat with a source So far we considered homogeneous wave and heat equations and the associated initial value problems on the whole line, as

More information

Isogeometric Analysis:

Isogeometric Analysis: Isogeometric Analysis: some approximation estimates for NURBS L. Beirao da Veiga, A. Buffa, Judith Rivas, G. Sangalli Euskadi-Kyushu 2011 Workshop on Applied Mathematics BCAM, March t0th, 2011 Outline

More information

ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS

ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS CARLO LOVADINA AND ROLF STENBERG Abstract The paper deals with the a-posteriori error analysis of mixed finite element methods

More information

Kasetsart University Workshop. Multigrid methods: An introduction

Kasetsart University Workshop. Multigrid methods: An introduction Kasetsart University Workshop Multigrid methods: An introduction Dr. Anand Pardhanani Mathematics Department Earlham College Richmond, Indiana USA pardhan@earlham.edu A copy of these slides is available

More information

Part IV: Numerical schemes for the phase-filed model

Part IV: Numerical schemes for the phase-filed model Part IV: Numerical schemes for the phase-filed model Jie Shen Department of Mathematics Purdue University IMS, Singapore July 29-3, 29 The complete set of governing equations Find u, p, (φ, ξ) such that

More information

Numerical Analysis Solution of Algebraic Equation (non-linear equation) 1- Trial and Error. 2- Fixed point

Numerical Analysis Solution of Algebraic Equation (non-linear equation) 1- Trial and Error. 2- Fixed point Numerical Analysis Solution of Algebraic Equation (non-linear equation) 1- Trial and Error In this method we assume initial value of x, and substitute in the equation. Then modify x and continue till we

More information

Applied Analysis (APPM 5440): Final exam 1:30pm 4:00pm, Dec. 14, Closed books.

Applied Analysis (APPM 5440): Final exam 1:30pm 4:00pm, Dec. 14, Closed books. Applied Analysis APPM 44: Final exam 1:3pm 4:pm, Dec. 14, 29. Closed books. Problem 1: 2p Set I = [, 1]. Prove that there is a continuous function u on I such that 1 ux 1 x sin ut 2 dt = cosx, x I. Define

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

Separation of Variables in Linear PDE: One-Dimensional Problems

Separation of Variables in Linear PDE: One-Dimensional Problems Separation of Variables in Linear PDE: One-Dimensional Problems Now we apply the theory of Hilbert spaces to linear differential equations with partial derivatives (PDE). We start with a particular example,

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

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

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

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

More information

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

u xx + u yy = 0. (5.1)

u xx + u yy = 0. (5.1) Chapter 5 Laplace Equation The following equation is called Laplace equation in two independent variables x, y: The non-homogeneous problem u xx + u yy =. (5.1) u xx + u yy = F, (5.) where F is a function

More information

A Locking-Free MHM Method for Elasticity

A Locking-Free MHM Method for Elasticity Trabalho apresentado no CNMAC, Gramado - RS, 2016. Proceeding Series of the Brazilian Society of Computational and Applied Mathematics A Locking-Free MHM Method for Elasticity Weslley S. Pereira 1 Frédéric

More information

( ε > 0) ( N N) ( n N) : n > N a n A < ε.

( ε > 0) ( N N) ( n N) : n > N a n A < ε. CHAPTER 1. LIMITS OF SEQUENCES 1.1. An Ad-hoc Definition. In mathematical analysis, the concept of limits is of paramount importance, in view of the fact that many basic objects of study such as derivatives,

More information

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications)

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications) Chapter 6 Finite Element Method Literature: (tiny selection from an enormous number of publications) K.J. Bathe, Finite Element procedures, 2nd edition, Pearson 2014 (1043 pages, comprehensive). Available

More information

Stochastic homogenization 1

Stochastic homogenization 1 Stochastic homogenization 1 Tuomo Kuusi University of Oulu August 13-17, 2018 Jyväskylä Summer School 1 Course material: S. Armstrong & T. Kuusi & J.-C. Mourrat : Quantitative stochastic homogenization

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

Method of Finite Elements I

Method of Finite Elements I Method of Finite Elements I PhD Candidate - Charilaos Mylonas HIL H33.1 and Boundary Conditions, 26 March, 2018 Institute of Structural Engineering Method of Finite Elements I 1 Outline 1 2 Penalty method

More information

TAYLOR POLYNOMIALS DARYL DEFORD

TAYLOR POLYNOMIALS DARYL DEFORD TAYLOR POLYNOMIALS DARYL DEFORD 1. Introduction We have seen in class that Taylor polynomials provide us with a valuable tool for approximating many different types of functions. However, in order to really

More information

WRT in 2D: Poisson Example

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

More information

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

Discontinuous Galerkin Methods

Discontinuous Galerkin Methods Discontinuous Galerkin Methods Joachim Schöberl May 20, 206 Discontinuous Galerkin (DG) methods approximate the solution with piecewise functions (polynomials), which are discontinuous across element interfaces.

More information

PART IV Spectral Methods

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

More information

Chapter 2. General concepts. 2.1 The Navier-Stokes equations

Chapter 2. General concepts. 2.1 The Navier-Stokes equations Chapter 2 General concepts 2.1 The Navier-Stokes equations The Navier-Stokes equations model the fluid mechanics. This set of differential equations describes the motion of a fluid. In the present work

More information

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

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

More information

A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators

A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators Jeff Ovall University of Kentucky Mathematics www.math.uky.edu/ jovall jovall@ms.uky.edu Kentucky Applied and

More information

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

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

More information

Discontinuous Petrov-Galerkin Methods

Discontinuous Petrov-Galerkin Methods Discontinuous Petrov-Galerkin Methods Friederike Hellwig 1st CENTRAL School on Analysis and Numerics for Partial Differential Equations, November 12, 2015 Motivation discontinuous Petrov-Galerkin (dpg)

More information

Page 52. Lecture 3: Inner Product Spaces Dual Spaces, Dirac Notation, and Adjoints Date Revised: 2008/10/03 Date Given: 2008/10/03

Page 52. Lecture 3: Inner Product Spaces Dual Spaces, Dirac Notation, and Adjoints Date Revised: 2008/10/03 Date Given: 2008/10/03 Page 5 Lecture : Inner Product Spaces Dual Spaces, Dirac Notation, and Adjoints Date Revised: 008/10/0 Date Given: 008/10/0 Inner Product Spaces: Definitions Section. Mathematical Preliminaries: Inner

More information

Lecture No 1 Introduction to Diffusion equations The heat equat

Lecture No 1 Introduction to Diffusion equations The heat equat Lecture No 1 Introduction to Diffusion equations The heat equation Columbia University IAS summer program June, 2009 Outline of the lectures We will discuss some basic models of diffusion equations and

More information

Introduction to Partial Differential Equations

Introduction to Partial Differential Equations Introduction to Partial Differential Equations Partial differential equations arise in a number of physical problems, such as fluid flow, heat transfer, solid mechanics and biological processes. These

More information

you expect to encounter difficulties when trying to solve A x = b? 4. A composite quadrature rule has error associated with it in the following form

you expect to encounter difficulties when trying to solve A x = b? 4. A composite quadrature rule has error associated with it in the following form Qualifying exam for numerical analysis (Spring 2017) Show your work for full credit. If you are unable to solve some part, attempt the subsequent parts. 1. Consider the following finite difference: f (0)

More information

Least-Squares Finite Element Methods

Least-Squares Finite Element Methods Pavel В. Bochev Max D. Gunzburger Least-Squares Finite Element Methods Spri ringer Contents Part I Survey of Variational Principles and Associated Finite Element Methods 1 Classical Variational Methods

More information

Electromagnetism HW 1 math review

Electromagnetism HW 1 math review Electromagnetism HW math review Problems -5 due Mon 7th Sep, 6- due Mon 4th Sep Exercise. The Levi-Civita symbol, ɛ ijk, also known as the completely antisymmetric rank-3 tensor, has the following properties:

More information

Math 5520 Homework 2 Solutions

Math 5520 Homework 2 Solutions Math 552 Homework 2 Solutions March, 26. Consider the function fx) = 2x ) 3 if x, 3x ) 2 if < x 2. Determine for which k there holds f H k, 2). Find D α f for α k. Solution. We show that k = 2. The formulas

More information

Introduction to Linear Algebra

Introduction to Linear Algebra Introduction to Linear Algebra Linear algebra is the algebra of vectors. In a course on linear algebra you will also learn about the machinery (matrices and reduction of matrices) for solving systems 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