New class of finite element methods: weak Galerkin methods

Size: px
Start display at page:

Download "New class of finite element methods: weak Galerkin methods"

Transcription

1 New class of finite element methods: weak Galerkin methods Xiu Ye University of Arkansas at Little Rock

2 Second order elliptic equation Consider second order elliptic problem: a u = f, in Ω (1) u = 0, on Ω. (2) Testing (1) by v H0 1 (Ω) gives a uvdx = a u vdx a u nvds = fvdx. Ω Ω Ω Ω where (f,g) = Ω fgdx. (a u, v) = (f, v),

3 PDE and its weak form PDE: find u satisfies a u = f, in Ω u = 0, on Ω. Its weak form: find u H0 1 (Ω) such that (a u, v) = (f, v), v H 1 0(Ω).

4 Infinity vs finite Weak form: find u H0 1 (Ω) such that (a u, v) = (f, v), v H 1 0(Ω). Let V h H0 1 (Ω) be a finite dimensional space. Continuous finite element method: find u h V h such that (a u h, v h ) = (f,v h ), v h V h,

5 Continuous finite element method Find u h V h such that (a u h, v h ) = (f, v h ), v h V h. Let V h = Span{φ 1,,φ n } and u h = n j=1 c jφ j, then n j=1 (a φ j, φ i )c j = (f, φ i ), i = 1,,n. The equation above is a symmetric and positive definite linear system. Solve it to obtain the finite element solution u h.

6 Limitations of the continuous finite element methods On approximation functions. P k only for triangles and Q k for quadrilaterals. Hard to construct high order and special elements such as C 1 conforming element. On mesh generation. Only triangular or quadrilateral meshes can be used in 2D. Hybrid meshes or meshes with hanging nodes are not allowed. Not compatible to hp adaptive technique.

7 Cause and solution Cause: Continuity requirement of approximating functions cross element boundaries. Solution: Use discontinuous approximations.

8 Pros and cons of using discontinuous functions Pros Flexibility on approximation functions. Polynomial P k can be used on any polygonal element. Easy to construct high order element. Flexibility on mesh generation. Hybrid meshes or meshes with hanging nodes are allowed. Compatible to hp adaptive technique. Cons There are more unknowns. Complexity in finite element formulations due to enforcing connections of numerical solutions between element boundaries.

9 Weak Galerkin finite element methods Weak Galerkin (WG) methods use discontinuous approximations. The WG methods keep the advantages: Flexible in approximations. Avoid construction of special elements such as C 1 conforming elements. Flexible in mesh generation. Hybrid meshes or meshes with hanging nodes can be used. and minimize the disadvantages: Simple formulations. Comparable number of unknowns to the continuous finite element methods if implemented appropriately.

10 Weak functions Let T be a quadrilateral with e j for j = 1,,4 as its four sides. Define { v0 P 1 (T ), in T 0 v = v b P 0 (e), on e T Define V h (T ) = {v L 2 (T ) : v = {v 0,v b }} = span{φ 1,,φ 7 } where { 1, on ei φ j = j = 1,,4 0, otherwise { { { 1, in T 0 x, in T 0 y, in T 0 φ 5 = φ 6 = φ 7 = 0, on T 0, on T 0, on T

11 Weak derivatives Define a weak gradient w v [P 0 (T )] 2 for v = {v 0,v b } V h (T ) on the element T : ( w v,q) T = (v 0, q) T + v b,q n T, q [P 0 (T )] 2. Let φ j = {φ j,0,φ j,b }, j = 1,,7. The definition of the weak gradient gives that for any q [P 0 (T )] 2 ( w φ 5,q) = (φ 5,0, q) T + φ 5,b,q n T = 0. We have w φ 5 = w φ 6 = w φ 7 = 0. Using the definition of w, we can find for j = 1,,4 w φ j = e j T n j. Weak gradient w for all the basis function φ j can be found explicitly.

12 The local stiffness matrix for the WG method Denote Q b the L 2 projection to P 0 (e j ). Q b v 0 ej = v 0 (m j ) where m j is the midpoint of e j. Define a T (v,w) = (a w v, w w) T + h 1 Q b v 0 v b,q b w 0 w b T. The local stiffness matrix A for the WG method on the element T for second order elliptic problem is a 7 7 matrix A = (a T (φ i,φ j )), i,j = 1,,7. e 4 e 1 T e 3 e 2

13 Weak Galerkin finite element methods Define weak function v = {v 0,v b } such that { v0, in T 0 v = v b, Define weak Galerkin finite element space on T V h = {v = {v 0,v b } : v 0 T P j (T ),v b P l (e),e T,v b = 0 on Ω}. Define a weak gradient w v [P r (T )] d for v V h on each element T : ( w v,q) T = (v 0, q) T + v b,q n T, q [P r (T )] d. Weak Galerkin element: (P j (T ),P l (e),[p r (T )] d ). For example: (P 1 (T ),P 0 (e),[p 0 (T )] d ).

14 Weak Galerkin finite element formulation Define a(u h,v h ) = (a w u h, w v h ) + h 1 T u 0 u b,v 0 v b T. T The WG method: find u h = {u 0,u b } V h satisfying a(u h,v h ) = (f,v h ), v h V h. Theorem. Let u h be the solution of the WG method associated with local spaces (P k (T ),P k (e),[p k 1 (T )] d ), then h Q h u u h + Q h u u h Ch k+1 u k+1, where Q h u is the L 2 projection of u.

15 Simple formulation: the WG method for the Stokes equations The weak form of the Stokes equations: find (u,p) [H0 1(Ω)]d L 2 0 (Ω) that for all (v,q) [H0 1(Ω)]d L 2 0 (Ω) ( u, v) ( v,p) = (f,v) ( u, q) = 0. The weak Galerkin method: find (u h,p h ) V h W h such that for all (v,q) V h W h, ( w u h, w v) + s(u h,v) ( w v,p h ) = (f,v) ( w u h, q) = 0.

16 The WG method for the biharmonic equation The weak form of the Stokes equations: seeking u H0 2 (Ω) satisfying ( u, v) = (f,v), v H 2 0(Ω), Weak Galerkin finite element method: seeking u h V h satisfying ( w u h, w v) + s(u h, v) = (f, v), v V h.

17 Implementation of the WG method The WG method: find u h = {u 0,u b } V h satisfying a(u h,v h ) = (f,v h ), v h = {v 0,v b } V h. Effective implementation of the WG method: 1. Solve u 0 as a function of u b from the following local system on element T, a(u h,v h ) = (f,v h ), v h = {v 0,0} V h. (3) 2. Solve u b from the following global system, a(u h,v h ) = (f,v h ), v h = {0,v b } V h. (4) Theorem. The global system (4) is symmetric and positive definite. For the lowest order WG method, the number of unknowns of (4) is # of unknowns = # of interior edges.

18 The recent development: The WG least-squares method Consider the model problem, a u = f, in Ω u = 0, on Ω. Rewrite the problem as the system of first order equations, q + a u = 0, in Ω, q = f, in Ω, u = 0, on Ω. The least-squares method: find (q,u) H(div;Ω) H0 1 (Ω) such that for any (σ,v) H(div;Ω) H0 1(Ω), (q + a u, σ + a v) + ( q, σ) = (f, σ).

19 The WG Least-squares method The least-squares method: find (q,u) H(div;Ω) H0 1 (Ω) such that for any (σ,v) H(div;Ω) H0 1(Ω), (q + a u, σ + a v) + ( q, σ) = (f, σ). The WG least-squares method: find (q h,u h ) Σ h V h such that for any (σ,v) Σ h V h, (q h + a w u h, σ + a w v) + ( w q h, w σ) + s 1 (u h,v) + s 2 (q h, σ) = (f, σ).

20 Define D h = {n e : n e is unit and normal to e, e E h }, V h = {v = {v 0,v b } : v 0 T P k+1 (T ),v b e P k (e),e T,v b = 0, on Ω}, Σ h = {σ = {σ 0, σ b } : σ 0 T [P k (T )] d, σ b e = σ b n e,σ b e P k (e), e T }. Define s 1 (w,v) = T T h h 1 Q b w 0 w b, Q b v 0 v b T, s 2 (t, σ) = T T h h (t 0 t b ) n, (σ 0 σ b ) n T, The WG least-squares method: find (q h,u h ) Σ h V h such that for any (σ,v) Σ h V h, (q h + a w u h, σ + a w v) + ( w q h, w σ) + s 1 (u h,v) + s 2 (q h, σ) = (f, σ).

21 We introduce a norm V in V h as and a norm Σ in Σ h as v 2 V = T T h w v 2 T + s 1 (v,v), σ 2 Σ = T T h w σ 2 T + σ s 2 (σ, σ). Lemma. There is a constant C such that for all (σ,v) Σ h V h C( σ 2 Σ + v 2 V ) a(v, σ;v, σ). Theorem. Assume the exact solution u H k+2 (Ω) and q [H k+1 (Ω)] d. Then, there exists a constant C such that u h Q h u V + q h Q h q Σ Ch k+1 ( u k+2 + q k+1 ).

22 Implementation of the WG least-squares method The WG least-squares method: find (q h,u h ) Σ h V h such that for any (σ,v) Σ h V h, (q h + a w u h, σ + a w v) + ( w q h, w σ) + s 1 (u h,v) + s 2 (q h, σ) = (f, σ). Effective implementation of the WG least-squares method: 1. Solve the local systems on each element T T h for any v = {v 0, 0} V h (T ) and σ = {σ 0,0} Σ h (T ), 2. Solve a global system, a(u h,q h ;v, σ) = (f, w σ) T. a(u h,q h ;v, σ) = 0, v = {0,v b } V h, σ = {0,q b } Σ h, (5) For the WG least-squares method with k = 0, # of unknowns = 2 # of interior edges.

23 Example: Let Ω = (0,1) (0,1) and the exact solution is given by u = x(1 x)y(1 y) h L 2 error order L 2 error order e e e e e e e e e e e e e e e e e e

24 The weak Galerkin method for the elliptic interface problems Consider a elliptic interface problem, A u = f, in Ω, u = 0, on Ω \ Γ, [[u]] Γ = ψ, on Γ, [[A u n]] Γ = φ, on Γ, V h = {v = {v 0,v b } : v 0 T P k (T ),v b e P k (e),e T,v b = 0,on, Ω} The weak Galerkin method: find u h V h such that (A w u h, w v) + T h 1 u 0 u b,v 0 v b T = (f,v 0 ) + ψ,a w v n Γ φ,v b Γ ψ,v 0 v b Γ, v V h.

25 Elliptic interface problems: Example 1 Ω = (0,1) 2 with Ω 1 = [0.2,0.8] 2 and Ω 2 = Ω/Ω 1. Then the exact solution: { 5 + 5(x 2 + y 2 ), if (x,y) Ω 1 u = x 2 + y 2 + sin(x + y), if (x,y) Ω 2 Permeability: A = { 1, if (x,y) Ω sin(x + y), if (x,y) Ω 2

26 Mesh 1 Mesh Solution on mesh 1 Solution on mesh 2

27 Elliptic interface problems: Example 2 The exact solution is u(x,y) = { x y if (x,y) Ω 1 e x cosπy otherwise Ω Ω Figure : The interface Γ in Example 2.

28 Mesh max{h} Gradient Solution L 2 error order L 2 error order Level e e e-01 Level e e e Level e e e Level e e e Level e e e Figure : The WG approximation of Example 2 on mesh level 5. Left: Numerical solution; Right: Exact solution.

29 Summary The weak Galerkin finite element methods represent advanced methodology for handling discontinuous functions in finite element procedure. The weak Galerkin finite element methods have the flexibility of using discontinuous elements and the simplicity of using continuous elements.

Weak Galerkin Finite Element Scheme and Its Applications

Weak Galerkin Finite Element Scheme and Its Applications Weak Galerkin Finite Element Scheme and Its Applications Ran Zhang Department of Mathematics Jilin University, China IMS, Singapore February 6, 2015 Talk Outline Motivation WG FEMs: Weak Operators + Stabilizer

More information

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

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

More information

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

Weak Galerkin Finite Element Methods and Applications

Weak Galerkin Finite Element Methods and Applications Weak Galerkin Finite Element Methods and Applications Lin Mu mul1@ornl.gov Computational and Applied Mathematics Computationa Science and Mathematics Division Oak Ridge National Laboratory Georgia Institute

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

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

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

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

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

1. Introduction. We consider the model problem that seeks an unknown function u = u(x) satisfying

1. Introduction. We consider the model problem that seeks an unknown function u = u(x) satisfying A SIMPLE FINITE ELEMENT METHOD FOR LINEAR HYPERBOLIC PROBLEMS LIN MU AND XIU YE Abstract. In this paper, we introduce a simple finite element method for solving first order hyperbolic equations with easy

More information

arxiv: v2 [math.na] 1 Aug 2018

arxiv: v2 [math.na] 1 Aug 2018 SIMPLIFIED WEAK GALERKIN AND NEW FINIE DIFFERENCE SCHEMES FOR HE SOKES EQUAION YUJIE LIU AND JUNPING WANG arxiv:1803.0010v [math.na] 1 Aug 018 Abstract. his article presents a simplified formulation for

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

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

A posteriori error estimation for elliptic problems

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

More information

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

An a posteriori error estimator for the weak Galerkin least-squares finite-element method

An a posteriori error estimator for the weak Galerkin least-squares finite-element method An a posteriori error estimator for the weak Galerkin least-squares finite-element method James H. Adler a, Xiaozhe Hu a, Lin Mu b, Xiu Ye c a Department of Mathematics, Tufts University, Medford, MA 02155

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

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

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

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

arxiv: v1 [math.na] 14 Apr 2011

arxiv: v1 [math.na] 14 Apr 2011 A WEAK GALERKIN FINIE ELEMEN MEHOD FOR SECOND-ORDER ELLIPIC PROBLEMS JUNPING WANG AND XIU YE arxiv:1104.2897v1 [math.na] 14 Apr 2011 Abstract. In this paper, authors shall introduce a finite element method

More information

A Least-Squares Finite Element Approximation for the Compressible Stokes Equations

A Least-Squares Finite Element Approximation for the Compressible Stokes Equations A Least-Squares Finite Element Approximation for the Compressible Stokes Equations Zhiqiang Cai, 1 Xiu Ye 1 Department of Mathematics, Purdue University, 1395 Mathematical Science Building, West Lafayette,

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

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

Hybridized Discontinuous Galerkin Methods

Hybridized Discontinuous Galerkin Methods Hybridized Discontinuous Galerkin Methods Theory and Christian Waluga Joint work with Herbert Egger (Uni Graz) 1st DUNE User Meeting, Stuttgart Christian Waluga (AICES) HDG Methods October 6-8, 2010 1

More information

1. Introduction. We consider the model problem: seeking an unknown function u satisfying

1. Introduction. We consider the model problem: seeking an unknown function u satisfying A DISCONTINUOUS LEAST-SQUARES FINITE ELEMENT METHOD FOR SECOND ORDER ELLIPTIC EQUATIONS XIU YE AND SHANGYOU ZHANG Abstract In tis paper, a discontinuous least-squares (DLS) finite element metod is introduced

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

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

Unified Hybridization Of Discontinuous Galerkin, Mixed, And Continuous Galerkin Methods For Second Order Elliptic Problems.

Unified Hybridization Of Discontinuous Galerkin, Mixed, And Continuous Galerkin Methods For Second Order Elliptic Problems. Unified Hybridization Of Discontinuous Galerkin, Mixed, And Continuous Galerkin Methods For Second Order Elliptic Problems. Stefan Girke WWU Münster Institut für Numerische und Angewandte Mathematik 10th

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

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

Local discontinuous Galerkin methods for elliptic problems

Local discontinuous Galerkin methods for elliptic problems COMMUNICATIONS IN NUMERICAL METHODS IN ENGINEERING Commun. Numer. Meth. Engng 2002; 18:69 75 [Version: 2000/03/22 v1.0] Local discontinuous Galerkin methods for elliptic problems P. Castillo 1 B. Cockburn

More information

A Numerical Study on the Weak Galerkin Method for the Helmholtz Equation

A Numerical Study on the Weak Galerkin Method for the Helmholtz Equation Commun. Comput. Phys. doi: 1.428/cicp.251112.21113a Vol. 15, No. 5, pp. 1461-1479 May 214 A Numerical Study on the Weak Galerkin Method for the Helmholtz Equation Lin Mu 1, Junping Wang 2, Xiu Ye 3 and

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

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

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

WEAK GALERKIN FINITE ELEMENT METHOD FOR SECOND ORDER PARABOLIC EQUATIONS

WEAK GALERKIN FINITE ELEMENT METHOD FOR SECOND ORDER PARABOLIC EQUATIONS INERNAIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume 13, Number 4, Pages 525 544 c 216 Institute for Scientific Computing and Information WEAK GALERKIN FINIE ELEMEN MEHOD FOR SECOND ORDER PARABOLIC

More information

A C 0 -Weak Galerkin Finite Element Method for the Biharmonic Equation

A C 0 -Weak Galerkin Finite Element Method for the Biharmonic Equation J Sci Comput (2014) 59:473 495 DOI 10.1007/s10915-013-9770-4 A C 0 -Weak Galerkin Finite Element Method for the Biharmonic Equation Lin Mu Junping Wang Xiu Ye Shangyou Zhang Received: 3 December 2012 /

More information

A Primal-Dual Weak Galerkin Finite Element Method for Second Order Elliptic Equations in Non-Divergence Form

A Primal-Dual Weak Galerkin Finite Element Method for Second Order Elliptic Equations in Non-Divergence Form A Primal-Dual Weak Galerkin Finite Element Method for Second Order Elliptic Equations in Non-Divergence Form Chunmei Wang Visiting Assistant Professor School of Mathematics Georgia Institute of Technology

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

An additive average Schwarz method for the plate bending problem

An additive average Schwarz method for the plate bending problem J. Numer. Math., Vol. 10, No. 2, pp. 109 125 (2002) c VSP 2002 Prepared using jnm.sty [Version: 02.02.2002 v1.2] An additive average Schwarz method for the plate bending problem X. Feng and T. Rahman Abstract

More information

STABILIZED DISCONTINUOUS FINITE ELEMENT APPROXIMATIONS FOR STOKES EQUATIONS

STABILIZED DISCONTINUOUS FINITE ELEMENT APPROXIMATIONS FOR STOKES EQUATIONS STABILIZED DISCONTINUOUS FINITE ELEMENT APPROXIMATIONS FOR STOKES EQUATIONS RAYTCHO LAZAROV AND XIU YE Abstract. In this paper, we derive two stabilized discontinuous finite element formulations, symmetric

More information

PDE & FEM TERMINOLOGY. BASIC PRINCIPLES OF FEM.

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

More information

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

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

More information

arxiv: v1 [math.na] 15 Nov 2017

arxiv: v1 [math.na] 15 Nov 2017 Noname manuscript No. (will be inserted by the editor) An HDG method with orthogonal projections in facet integrals Issei Oikawa arxiv:1711.05396v1 [math.na] 15 Nov 2017 Received: date / Accepted: date

More information

NONSTANDARD NONCONFORMING APPROXIMATION OF THE STOKES PROBLEM, I: PERIODIC BOUNDARY CONDITIONS

NONSTANDARD NONCONFORMING APPROXIMATION OF THE STOKES PROBLEM, I: PERIODIC BOUNDARY CONDITIONS NONSTANDARD NONCONFORMING APPROXIMATION OF THE STOKES PROBLEM, I: PERIODIC BOUNDARY CONDITIONS J.-L. GUERMOND 1, Abstract. This paper analyzes a nonstandard form of the Stokes problem where the mass conservation

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

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

ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS

ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS MATHEMATICS OF COMPUTATION Volume 75, Number 256, October 2006, Pages 1659 1674 S 0025-57180601872-2 Article electronically published on June 26, 2006 ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED

More information

HIGH DEGREE IMMERSED FINITE ELEMENT SPACES BY A LEAST SQUARES METHOD

HIGH DEGREE IMMERSED FINITE ELEMENT SPACES BY A LEAST SQUARES METHOD INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume 14, Number 4-5, Pages 604 626 c 2017 Institute for Scientific Computing and Information HIGH DEGREE IMMERSED FINITE ELEMENT SPACES BY A LEAST

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

Discontinuous Galerkin Methods: Theory, Computation and Applications

Discontinuous Galerkin Methods: Theory, Computation and Applications Discontinuous Galerkin Methods: Theory, Computation and Applications Paola. Antonietti MOX, Dipartimento di Matematica Politecnico di Milano.MO. X MODELLISTICA E CALCOLO SCIENTIICO. MODELING AND SCIENTIIC

More information

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Roy Stogner Computational Fluid Dynamics Lab Institute for Computational Engineering and Sciences University of Texas at Austin March

More information

A Two-grid Method for Coupled Free Flow with Porous Media Flow

A Two-grid Method for Coupled Free Flow with Porous Media Flow A Two-grid Method for Coupled Free Flow with Porous Media Flow Prince Chidyagwai a and Béatrice Rivière a, a Department of Computational and Applied Mathematics, Rice University, 600 Main Street, Houston,

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

The Discontinuous Galerkin Finite Element Method

The Discontinuous Galerkin Finite Element Method The Discontinuous Galerkin Finite Element Method Michael A. Saum msaum@math.utk.edu Department of Mathematics University of Tennessee, Knoxville The Discontinuous Galerkin Finite Element Method p.1/41

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

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

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

weak Galerkin, finite element methods, interior estimates, second-order elliptic

weak Galerkin, finite element methods, interior estimates, second-order elliptic INERIOR ENERGY ERROR ESIMAES FOR HE WEAK GALERKIN FINIE ELEMEN MEHOD HENGGUANG LI, LIN MU, AND XIU YE Abstract Consider the Poisson equation in a polytopal domain Ω R d (d = 2, 3) as the model problem

More information

Discontinuous Galerkin and Finite Difference Methods for the Acoustic Equations with Smooth Coefficients. Mario Bencomo TRIP Review Meeting 2013

Discontinuous Galerkin and Finite Difference Methods for the Acoustic Equations with Smooth Coefficients. Mario Bencomo TRIP Review Meeting 2013 About Me Mario Bencomo Currently 2 nd year graduate student in CAAM department at Rice University. B.S. in Physics and Applied Mathematics (Dec. 2010). Undergraduate University: University of Texas at

More information

Non-Newtonian Fluids and Finite Elements

Non-Newtonian Fluids and Finite Elements Non-Newtonian Fluids and Finite Elements Janice Giudice Oxford University Computing Laboratory Keble College Talk Outline Motivating Industrial Process Multiple Extrusion of Pastes Governing Equations

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

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

Maximum-norm a posteriori estimates for discontinuous Galerkin methods

Maximum-norm a posteriori estimates for discontinuous Galerkin methods Maximum-norm a posteriori estimates for discontinuous Galerkin methods Emmanuil Georgoulis Department of Mathematics, University of Leicester, UK Based on joint work with Alan Demlow (Kentucky, USA) DG

More information

Numerical Experiments Using MATLAB: Superconvergence of Nonconforming Finite Element Approximation for Second-Order Elliptic Problems

Numerical Experiments Using MATLAB: Superconvergence of Nonconforming Finite Element Approximation for Second-Order Elliptic Problems Applied Matematics, 06, 7, 74-8 ttp://wwwscirporg/journal/am ISSN Online: 5-7393 ISSN Print: 5-7385 Numerical Experiments Using MATLAB: Superconvergence of Nonconforming Finite Element Approximation for

More information

Partially Penalized Immersed Finite Element Methods for Parabolic Interface Problems

Partially Penalized Immersed Finite Element Methods for Parabolic Interface Problems Partially Penalized Immersed Finite Element Methods for Parabolic Interface Problems Tao Lin, Qing Yang and Xu Zhang Abstract We present partially penalized immersed finite element methods for solving

More information

FEniCS Course. Lecture 0: Introduction to FEM. Contributors Anders Logg, Kent-Andre Mardal

FEniCS Course. Lecture 0: Introduction to FEM. Contributors Anders Logg, Kent-Andre Mardal FEniCS Course Lecture 0: Introduction to FEM Contributors Anders Logg, Kent-Andre Mardal 1 / 46 What is FEM? The finite element method is a framework and a recipe for discretization of mathematical problems

More information

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

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

More information

A Gradient Recovery Operator Based on an Oblique Projection

A Gradient Recovery Operator Based on an Oblique Projection A Gradient Recovery Operator Based on an Bishnu P. Lamichhane, bishnu.lamichhane@newcastle.edu.au School of Mathematical and Physical Sciences, University of Newcastle, Australia CARMA Retreat July 18,

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

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

Non-Conforming Finite Element Methods for Nonmatching Grids in Three Dimensions

Non-Conforming Finite Element Methods for Nonmatching Grids in Three Dimensions Non-Conforming Finite Element Methods for Nonmatching Grids in Three Dimensions Wayne McGee and Padmanabhan Seshaiyer Texas Tech University, Mathematics and Statistics (padhu@math.ttu.edu) Summary. In

More information

Discontinuous Galerkin Methods: An Overview and Some Applications. Daya Reddy UNIVERSITY OF CAPE TOWN

Discontinuous Galerkin Methods: An Overview and Some Applications. Daya Reddy UNIVERSITY OF CAPE TOWN Discontinuous Galerkin Methods: An Overview and Some Applications Daya Reddy UNIVRSITY OF CAP TOWN Joint work with Beverley Grieshaber and Andrew McBride SANUM, Stellenbosch, 22 24 March 2016 Structure

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

arxiv: v1 [math.na] 11 Sep 2017

arxiv: v1 [math.na] 11 Sep 2017 Dual virtual element method in presence of an inclusion Alessio Fumagalli arxiv:1709.03519v1 [math.na] 11 Sep 2017 Abstract We consider a Darcy problem for saturated porous media written in dual formulation

More information

arxiv: v1 [math.na] 5 Mar 2013

arxiv: v1 [math.na] 5 Mar 2013 WEAK GALERKIN FINIE ELEMEN MEHODS FOR HE BIHARMONIC EQUAION ON POLYOPAL MESHES LIN MU, JUNPING WANG, AND XIU YE arxiv:133.97v1 [math.na] 5 Mar 13 Abstract. A new weak Galerkin (WG) finite element method

More information

Static condensation, hybridization, and the devising of the HDG methods

Static condensation, hybridization, and the devising of the HDG methods Static condensation, hybridization, and the devising of the HDG methods Bernardo Cockburn Abstract In this paper, we review and refine the main ideas for devising the so-called hybridizable discontinuous

More information

Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions

Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions Ernst P. Stephan 1, Matthias Maischak 2, and Thanh Tran 3 1 Institut für Angewandte Mathematik, Leibniz

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 POSTERIORI ERROR ESTIMATES OF TRIANGULAR MIXED FINITE ELEMENT METHODS FOR QUADRATIC CONVECTION DIFFUSION OPTIMAL CONTROL PROBLEMS

A POSTERIORI ERROR ESTIMATES OF TRIANGULAR MIXED FINITE ELEMENT METHODS FOR QUADRATIC CONVECTION DIFFUSION OPTIMAL CONTROL PROBLEMS A POSTERIORI ERROR ESTIMATES OF TRIANGULAR MIXED FINITE ELEMENT METHODS FOR QUADRATIC CONVECTION DIFFUSION OPTIMAL CONTROL PROBLEMS Z. LU Communicated by Gabriela Marinoschi In this paper, we discuss a

More information

MORTAR MULTISCALE FINITE ELEMENT METHODS FOR STOKES-DARCY FLOWS

MORTAR MULTISCALE FINITE ELEMENT METHODS FOR STOKES-DARCY FLOWS MORTAR MULTISCALE FINITE ELEMENT METHODS FOR STOKES-DARCY FLOWS VIVETTE GIRAULT, DANAIL VASSILEV, AND IVAN YOTOV Abstract. We investigate mortar multiscale numerical methods for coupled Stokes and Darcy

More information

Optimal multilevel preconditioning of strongly anisotropic problems.part II: non-conforming FEM. p. 1/36

Optimal multilevel preconditioning of strongly anisotropic problems.part II: non-conforming FEM. p. 1/36 Optimal multilevel preconditioning of strongly anisotropic problems. Part II: non-conforming FEM. Svetozar Margenov margenov@parallel.bas.bg Institute for Parallel Processing, Bulgarian Academy of Sciences,

More information

arxiv: v2 [math.na] 6 Jul 2018

arxiv: v2 [math.na] 6 Jul 2018 NEW HIGHER-ORDER MASS-LUMPED TETRAHEDRAL ELEMENTS FOR WAVE PROPAGATION MODELLING* S. GEEVERS 1, W.A. MULDER 2,3 AND J.J.W. VAN DER VEGT 1 1. Department of Applied Mathematics, University of Twente, Enschede,

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

G. R. Liu 1,2,, Received 17 July 2008; Revised 6 June 2009; Accepted 23 June 2009 KEY WORDS:

G. R. Liu 1,2,, Received 17 July 2008; Revised 6 June 2009; Accepted 23 June 2009 KEY WORDS: INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN ENGINEERING Int. J. Numer. Meth. Engng 2010; 81:1127 1156 Published online 17 August 2009 in Wiley InterScience (www.interscience.wiley.com)..2720 A G space

More information

THE PATCH RECOVERY FOR FINITE ELEMENT APPROXIMATION OF ELASTICITY PROBLEMS UNDER QUADRILATERAL MESHES. Zhong-Ci Shi and Xuejun Xu.

THE PATCH RECOVERY FOR FINITE ELEMENT APPROXIMATION OF ELASTICITY PROBLEMS UNDER QUADRILATERAL MESHES. Zhong-Ci Shi and Xuejun Xu. DISCRETE AND CONTINUOUS Website: http://aimsciences.org DYNAMICAL SYSTEMS SERIES B Volume 9, Number, January 2008 pp. 63 82 THE PATCH RECOVERY FOR FINITE ELEMENT APPROXIMATION OF ELASTICITY PROBLEMS UNDER

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

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

BUBBLE STABILIZED DISCONTINUOUS GALERKIN METHOD FOR STOKES PROBLEM

BUBBLE STABILIZED DISCONTINUOUS GALERKIN METHOD FOR STOKES PROBLEM BUBBLE STABILIZED DISCONTINUOUS GALERKIN METHOD FOR STOKES PROBLEM ERIK BURMAN AND BENJAMIN STAMM Abstract. We propose a low order discontinuous Galerkin method for incompressible flows. Stability of the

More information

Graded Mesh Refinement and Error Estimates of Higher Order for DGFE-solutions of Elliptic Boundary Value Problems in Polygons

Graded Mesh Refinement and Error Estimates of Higher Order for DGFE-solutions of Elliptic Boundary Value Problems in Polygons Graded Mesh Refinement and Error Estimates of Higher Order for DGFE-solutions of Elliptic Boundary Value Problems in Polygons Anna-Margarete Sändig, Miloslav Feistauer University Stuttgart, IANS Journées

More information

A COMPUTATIONAL STUDY OF THE WEAK GALERKIN METHOD FOR SECOND-ORDER ELLIPTIC EQUATIONS

A COMPUTATIONAL STUDY OF THE WEAK GALERKIN METHOD FOR SECOND-ORDER ELLIPTIC EQUATIONS A COMPUTATIONAL STUDY OF THE WEA GALERIN METHOD FOR SECOND-ORDER ELLIPTIC EQUATIONS LIN MU, JUNPING WANG, YANQIU WANG, AND XIU YE Abstract. The weak Galerkin finite element method is a novel numerical

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

Remarks on the analysis of finite element methods on a Shishkin mesh: are Scott-Zhang interpolants applicable?

Remarks on the analysis of finite element methods on a Shishkin mesh: are Scott-Zhang interpolants applicable? Remarks on the analysis of finite element methods on a Shishkin mesh: are Scott-Zhang interpolants applicable? Thomas Apel, Hans-G. Roos 22.7.2008 Abstract In the first part of the paper we discuss minimal

More information

Numerical Analysis of Higher Order Discontinuous Galerkin Finite Element Methods

Numerical Analysis of Higher Order Discontinuous Galerkin Finite Element Methods Numerical Analysis of Higher Order Discontinuous Galerkin Finite Element Methods Contents Ralf Hartmann Institute of Aerodynamics and Flow Technology DLR (German Aerospace Center) Lilienthalplatz 7, 3808

More information

A BIVARIATE SPLINE METHOD FOR SECOND ORDER ELLIPTIC EQUATIONS IN NON-DIVERGENCE FORM

A BIVARIATE SPLINE METHOD FOR SECOND ORDER ELLIPTIC EQUATIONS IN NON-DIVERGENCE FORM A BIVARIAE SPLINE MEHOD FOR SECOND ORDER ELLIPIC EQUAIONS IN NON-DIVERGENCE FORM MING-JUN LAI AND CHUNMEI WANG Abstract. A bivariate spline method is developed to numerically solve second order elliptic

More information

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

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

More information

Institut de Recherche MAthématique de Rennes

Institut de Recherche MAthématique de Rennes LMS Durham Symposium: Computational methods for wave propagation in direct scattering. - July, Durham, UK The hp version of the Weighted Regularization Method for Maxwell Equations Martin COSTABEL & Monique

More information

A Balancing Algorithm for Mortar Methods

A Balancing Algorithm for Mortar Methods A Balancing Algorithm for Mortar Methods Dan Stefanica Baruch College, City University of New York, NY, USA. Dan_Stefanica@baruch.cuny.edu Summary. The balancing methods are hybrid nonoverlapping Schwarz

More information

Multigrid Methods for Maxwell s Equations

Multigrid Methods for Maxwell s Equations Multigrid Methods for Maxwell s Equations Jintao Cui Institute for Mathematics and Its Applications University of Minnesota Outline Nonconforming Finite Element Methods for a Two Dimensional Curl-Curl

More information