Weak Galerkin Finite Element Methods and Applications

Size: px
Start display at page:

Download "Weak Galerkin Finite Element Methods and Applications"

Transcription

1 Weak Galerkin Finite Element Methods and Applications Lin Mu Computational and Applied Mathematics Computationa Science and Mathematics Division Oak Ridge National Laboratory Georgia Institute of Technology Oct 26-28, 2015 Lin Mu WGFEM and Applications Oct 26-29, / 34

2 Outline Weak Galerkin Finite Element Methods Motivation Implementation Applications Brinkman Problems Multiscale Weak Galerkin Finite Element Methods Solution Boundedness Summary and Future Work Joint Work with: Dr. Junping Wang, Dr. Guowei Wei, Dr. Xiu Ye Lin Mu WGFEM and Applications Oct 26-29, / 34

3 WGFEM Table of Contents 1 Weak Galerkin Finite Element Methods Motivation Implementation 2 Applications Brinkman Problems Multiscale Weak Galerkin Finite Element Methods Solution Boundedness 3 Summary and Future Work Summary Future Work Lin Mu WGFEM and Applications Oct 26-29, / 34

4 WGFEM Motivation Limitations of Continuous Finite Element Methods Lowest order of element does not work P 1 P 0 Continuous element not stable for Stokes problem Difficult to construct high order continuous elements. C 1 element: Argyris element, polynomial with degree 5 Not compatible to modern techniques in scientific computing. hp adaptive technique Hybrid mesh Figure: Argyris Finite Element Figure: Hp adaptive Finite Element Figure: Hybrid mesh Lin Mu WGFEM and Applications Oct 26-29, / 34

5 WGFEM Implementation Weak Galerkin Formulation The weak form of the PDE: seeking u H0 1 (Ω) satisfying: (a u, v) = (f, v), v H 1 0 (Ω). Weak Galerkin finite element method: seeking u h V h satisfying: (a w u h, w v) + s(u h, v) = (f, v), v V h, where s(u h, v) = K h 1 K u 0 u b, v 0 v b K Honeycomb mesh Mesh with hanging nodes Lin Mu WGFEM and Applications Oct 26-29, / 34

6 WGFEM Implementation Weak Galerkin Formulation The weak form of the PDE: seeking u H0 1 (Ω) satisfying: (a u, v) = (f, v), v H 1 0 (Ω). Weak Galerkin finite element method: seeking u h V h satisfying: (a w u h, w v) + s(u h, v) = (f, v), v V h, where s(u h, v) = K h 1 K u 0 u b, v 0 v b K. Like traditional FEM (CG) to compute ( u h, v), for WG we need to compute: 1 (a w u h, w v) = (a w u h, w v) K. K 1 L. Mu, J. Wang, and X. Ye. Weak Galerkin Finite Element Methods on Polytopal Meshes. International Journal of Numerical Analysis and Modeling. 12 (2015), Lin Mu WGFEM and Applications Oct 26-29, / 34

7 WGFEM Implementation Example of WG Element: P 1 (K 0 ), P 0 (e) Calculating: w v [P 0 (K)] 2, with v V h = {(v 0, v b ) : v 0 K P 1 (K 0 ), v b P 0 (e), v b = 0 on Ω} V h = span{φ 0,i, Φ b,j }, i = 1,..., n p, j = 1,..., n e Φ 0,i = Φ b,j = { P 1 (K) on K 0 0, otherwise { 1, on e j 0, otherwise. V 0 e 2 e 1 e 3 e 3 Figure: (a). Φ 0,i is defined on K 0 ; (b). Φ b,j is defined on K. e l e 6 e 5 V b Lin Mu WGFEM and Applications Oct 26-29, / 34

8 WGFEM Implementation Example of WG Element: P 1 (K 0 ), P 0 (e) Calculating: w v [P 0 (K)] 2, with v V h = {(v 0, v b ) : v 0 K P 1 (K 0 ), v b P 0 (e), v b = 0 on Ω} V h = span{φ 0,i, Φ b,j }, i = 1,..., n p, j = 1,..., n e Φ 0,i = Φ b,j = { P 1 (K) on K 0 0, otherwise { 1, on e j 0, otherwise. V 0 e 2 e 1 e 3 e 3 Figure: (a). Φ 0,i is defined on K 0 ; (b). Φ b,j is defined on K. e l e 6 e 5 V b ( w v, q) K = (v 0, q) K + v b, q n K Lin Mu WGFEM and Applications Oct 26-29, / 34

9 WGFEM Implementation ( w v, q) K = (v 0, q) K + v b, q n K w Φ 0,i K = 0, w Φ b,j K = e j K n j,k. Lin Mu WGFEM and Applications Oct 26-29, / 34 Example of WG Element: P 1 (K 0 ), P 0 (e) Calculating: w v [P 0 (K)] 2, with v V h = {(v 0, v b ) : v 0 K P 1 (K 0 ), v b P 0 (e), v b = 0 on Ω} V h = span{φ 0,i, Φ b,j }, i = 1,..., n p, j = 1,..., n e Φ 0,i = Φ b,j = { P 1 (K) on K 0 0, otherwise { 1, on e j 0, otherwise. V 0 e 2 e 1 e 3 e 3 Figure: (a). Φ 0,i is defined on K 0 ; (b). Φ b,j is defined on K. e l e 6 e 5 V b

10 WGFEM Implementation Weak Galerkin Numerical Schemes Weak Galerkin finite element method for Stokes equations: 2 seeking (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. Weak Galerkin finite element method for Biharmonic equations: 3 seeking u h V h satisfying ( w u h, w v) + s(u h, v) = (f, v), v V h. 2 J. Wang, and X. Ye. A Weak Galerkin Finite Element Method for the Stokes Equations, arxiv: L. Mu, J. Wang, and X. Ye. Weak Galerkin Finite Element Methods for the Biharmonic Equation on Polytopal Meshes. Numerical Methods for Partial Differential Equations, 30 (2014): Lin Mu WGFEM and Applications Oct 26-29, / 34

11 Table of Contents 1 Weak Galerkin Finite Element Methods Motivation Implementation 2 Applications Brinkman Problems Multiscale Weak Galerkin Finite Element Methods Solution Boundedness 3 Summary and Future Work Summary Future Work Lin Mu WGFEM and Applications Oct 26-29, / 34

12 Brinkman Application 1: Brinkman Problems Brinkman equations: ɛ 2 u + u + p = f, in Ω, u = g, in Ω where 0 ɛ 2 1. Stokes equations: u + p = f, in Ω, u = 0, in Ω Darcy equations: u + p = 0, in Ω, u = g, in Ω Lin Mu WGFEM and Applications Oct 26-29, / 34

13 Brinkman Challenge of algorithm design for the Brinkman equations The main challenge for solving Brinkman equations is in the construction of numerical schemes that are stable for both the Darcy flow and the Stokes flow. Stokes stable elements such as Crouzeix-Raviart element, MINI element and Taylor-Hood element do not work well for the Darcy flow (small ɛ). Darcy stable elements such as RT elements and BDM elements do not work well for the Stokes flow (large ɛ). Lin Mu WGFEM and Applications Oct 26-29, / 34

14 Brinkman WG methods for the Brinkman equations The weak form of the Brinkman equations: find (u, p) H 1 0 (Ω)d L 2 0 (Ω) s.t. for (v, q) H1 0 (Ω)d L 2 0 (Ω) ɛ 2 ( u, v) + (u, v) ( v, p) = (f, v), ( u, q) = (g, q). Weak Galerkin finite element methods 4 for the Brinkman equations: find (u h, p h ) V h W h s.t. for (v, q) V h W h ɛ 2 ( w u h, w v) + (u 0, v 0 ) + s(u h, v) ( w v, p h ) = (f, v), ( w u h, q) = (g, q), where s(v, w) = K T h h 1 K v 0 v b, w 0 w b K. 4 Mu, L., Wang, J., Ye, X.. A stable numerical algorithm for the Brinkman equations by weak Galerkin finite element methods. Journal of Computational Physics. (2014) Lin Mu WGFEM and Applications Oct 26-29, / 34

15 Brinkman Uniform convergence rate of WG method Theorem (Mu, Wang, Ye, 2014, Uniform convergence rate) Let (u; p) (H 1 0 (Ω) Hk+1 (Ω)) d L 2 0 (Ω) Hk (Ω) with k 1 be the solution of the Brinkman equations and (u h ; p h ) V h W h be the solutions of the weak Galerkin methods. Then Q h u u h + Q h p p h Ch k ( u k+1 + p k ), Q 0 u u 0 Ch k+1 ( u k+1 + p k ). where C is a constant independent of h and ɛ. Lin Mu WGFEM and Applications Oct 26-29, / 34

16 Brinkman WG Methods for Brinkman Problems Example 1. Let Ω = (0, 1) 2, u = curl(sin 2 (πx) sin 2 (πy)), and p = sin(πx). Table: Numerical Convergence Test for Crouzeix Raviart element, Raviart Thomas element, and WG element. ɛ Crouzeix-Raviart rate H 1,velocity rate L 2,pressure Lin Mu WGFEM and Applications Oct 26-29, / 34

17 Brinkman WG Methods for Brinkman Problems Example 1. Let Ω = (0, 1) 2, u = curl(sin 2 (πx) sin 2 (πy)), and p = sin(πx). Table: Numerical Convergence Test for Crouzeix Raviart element, Raviart Thomas element, and WG element. ɛ Crouzeix-Raviart rate H 1,velocity rate L 2,pressure Raviart-Thomas rate H 1,velocity rate L 2,pressure Lin Mu WGFEM and Applications Oct 26-29, / 34

18 Brinkman WG Methods for Brinkman Problems Example 1. Let Ω = (0, 1) 2, u = curl(sin 2 (πx) sin 2 (πy)), and p = sin(πx). Table: Numerical Convergence Test for Crouzeix Raviart element, Raviart Thomas element, and WG element. ɛ Crouzeix-Raviart rate H 1,velocity rate L 2,pressure Raviart-Thomas rate H 1,velocity rate L 2,pressure WG-FEM rate H 1,velocity rate L 2, velocity rate L 2, pressure Lin Mu WGFEM and Applications Oct 26-29, / 34

19 Brinkman WG Methods for Brinkman Problems Next, we use the Brinkman equation in the following equivalent form for the following more practical examples: µ u + p + µκ 1 u = f, in Ω (1) Here κ denotes the permeability. Below, we shall: (1) Taking both µ and κ as variants. u = 0, in Ω (2) u = g. (3) (2) Investigate the performance of weak Galerkin algorithm to more practical problems. For all the following test problems, we have the same setting: Ω = (0, 1) (0, 1), µ = 0.01, f = 0, g = [1, 0] T. Lin Mu WGFEM and Applications Oct 26-29, / 34

20 Brinkman WG Methods for Brinkman Problems Example 2. Fluid flow in Vuggy reservoirs. Figure: (a) Profile of κ 1 for vuggy medium; (b) Pressure profile; (c) Velocity of x component; (d) Velocity of y component. Lin Mu WGFEM and Applications Oct 26-29, / 34

21 Brinkman WG Methods for Brinkman Problems Example 3. Flow through fibrous materials. Figure: (a) Profile of κ 1 for fibrous materials; (b) Pressure profile; (c) Velocity of x component; (d) Velocity of y component. Lin Mu WGFEM and Applications Oct 26-29, / 34

22 Brinkman WG Methods for Brinkman Problems Example 4. Flow through open foam. Figure: (a) Profile of κ 1 for open foam; (b) Pressure profile; (c) Velocity of x component; (d) Velocity of y component. Lin Mu WGFEM and Applications Oct 26-29, / 34

23 MsWG Application 2: Multiscale Weak Galerkin Finite Element Methods Many scientific and engineering problems involve multiple scales Difficulty of direct numerical solution: size of the computation ɛ = 0.4, P = 1.8 ɛ = 0.2, P = 1.8 ɛ = 0.1, P = 1.8 Figure: Plot of a(x/ɛ) = 1 4+P (sin(2πx/ɛ)+sin(2πy/ɛ)) Lin Mu WGFEM and Applications Oct 26-29, / 34

24 MsWG Multiscale Weak Galerkin Finite Element Methods Capture the multiscale structure of the solution via localized basis functions Basis functions contain information about the scales that are smaller than the local numerical scale (muliscale information) Let T H be a partition of Ω into coarse elements K. On each element K T H, Ψ j is the solution of the local problem: Ψ j = Φ e,j on K and Define WG multiscale vector space: a K (Ψ j, v) = 0, v V 0 h (K) V S H = span{ψ 1,, Ψ n }. Weak Galerkin multiscale method: Find Φ H V S H satisfying a(φ H, v) = (f, v), v V S H (4) Lin Mu WGFEM and Applications Oct 26-29, / 34

25 MsWG Part I: Multiscale Weak Galerkin FEM (MsWG) K K Lin Mu WGFEM and Applications Oct 26-29, / 34

26 MsWG Part I: Multiscale Weak Galerkin FEM (MsWG) K K Figure: Coarse Mesh VS Fine Mesh Degree of Freedom Lin Mu WGFEM and Applications Oct 26-29, / 34

27 MsWG Part I: Multiscale Weak Galerkin FEM (MsWG) K K Figure: Coarse Mesh VS Fine Mesh Degree of Freedom Theorem a Let Φ H and u h be the solutions of the WG multiscale method in snapshot space and WG method on the find grid respectively. Then we have u h Φ H CH f. (5) a Efendiev, Y., Mu, L., Wang, J., Ye, X. A weak Galerkin general mutiscale finite element method, in processing. Lin Mu WGFEM and Applications Oct 26-29, / 34

28 MsWG Numerical Results for MsWG Example 5. Problem is set as Ω = (0, 1) 2, a = I and u = cos(πx) cos(πy). Table: Example 5. Convergence rate for triangular mesh: Linear and quadratic weak Galerkin elements. Mesh u h Φ H order u h Φ H order Linear weak Galerkin element Level e e-2 Level e e Level e e Level e e Level e e Level e e Quadratic weak Galerkin element Level e e-3 Level e e Level e e Level e e Level e e Level e e Lin Mu WGFEM and Applications Oct 26-29, / 34

29 MsWG Example 6: a(x/ɛ) = 1 4+P (sin(2πx/ɛ)+sin(2πy/ɛ)) and u = 4 P 2 2 (x 2 + y 2 ). Table: Example 6. Convergence rate: Linear weak Galerkin element on triangular mesh with fixed H = 1/8. ɛ = 0.4 ɛ = 0.2 ɛ = 0.1 H/h u h Φ H order u h Φ H order u h Φ H order e e e e e e e e e e e e e e e e e e e e e Lin Mu WGFEM and Applications Oct 26-29, / 34

30 MsWG Part II: Basis Reduction Associated each E i, an edge in coarse mesh T H, We will solve an eigenvalue problem: find λ and Z i V H (E i ) in ω(e i ) such that where a i (Z i, w) = λ i S i (Z i, w), w Θ i (6) a i (v, w) = K ω i (a w v, w w) K + h 1 v 0 v b, w 0 w b K, S i (v, w) = K ω i h 1 v 0 v b, w 0 w b K. Eigenvalues and eigenvectors: λ i 1 λ i 2 λ i J i, {Z i 1, Z i 2,, Z i J i } Lin Mu WGFEM and Applications Oct 26-29, / 34

31 MsWG Part II: Basis Reduction Define ξj i = J i m=1 zi j,m Ψ i,m, m = 1,, J i. Define VH r (E i) V H (E i ) for M i J i, VH r (E i) = span{ξ1 i, ξi 2,, ξi M i }. Let VH r be s subspace of V H, VH r = M i=1 V H r. Find u H VH r such that a(u H, v) = (f, v), v V r H. (7) Theorem Let u h and u H be the solutions of the WG method on the fine grid and the WG-GMS method respectively. The we have for k = 1 u h u H C(H f + Λ 1/2 Ψ H ), (8) where Λ = min M i=1 λi M i with M the number of E EH 0 and Ψ H is the solution of weak Galerkin multiscale methods. Lin Mu WGFEM and Applications Oct 26-29, / 34

32 MsWG Numerical Experiment of GMsWG Figure: Example 7. (a). Plot of high contrast coefficient; (b). Reduction of eigenvalues; (c). Reference solution; (d). GMsWG solution. Table: Example 7. Error profiles. n = 100, N = 5 n = 100, N = 10 n = 100, N = 20 dof per E u H u h / u h u H u h / u h u H u h / u h e e e e e e e e e e e e e e e e e e e e e Lin Mu WGFEM and Applications Oct 26-29, / 34

33 Solution Boundedness Application 3: Solution Boundedness Example 8: (Numerical Locking) In this test, the permeability tensor is defined by 5 D = ( ) 1 0, with δ = 10 5 or δ The exact solution is taken to be u = sin(2πx)e 2π 1/δy. We consider elliptic problem with non-homogeneous Neumann boundary condition and right hand side is f = (D u). The uniqueness of solution is enforced by Ω udx = 0. Some numerical locking for finite element scheme. 5 Raphaele Herbin and Florence Hubert, Benchmark on Discretization Schemes for Anisotropic Diffusion Problems on General Grids, Finite volumes for complex applications V, Wiley, Lin Mu WGFEM and Applications Oct 26-29, / 34

34 Solution Boundedness Numerical Results for Numerical Locking Problem Figure: Example 8. (a). Mesh 1; (b). Exact solution Table: Example 8. Maxmimum and Minimum values of CG and WG element on Mesh 1. Continuous element WG element δ = 1e5 Min Max Min Max e e e e-1 δ = 1e6 Min Max Min Max e e e e-1 Lin Mu WGFEM and Applications Oct 26-29, / 34

35 Solution Boundedness Numerical Results for Numerical Locking Problem Table: Example 8. Maxmimum and Minimum values of CG and WG element on Mesh 2 and Mesh 3. Continuous element WG element δ = 1e5 Min Max Min Max Mesh e e e e-1 Mesh e e e e-1 δ = 1e6 Min Max Min Max Mesh e e e e-1 Mesh e e e e-1 Lin Mu WGFEM and Applications Oct 26-29, / 34

36 Applications Solution Boundedness Plots for Numerical Locking Problem Figure: Example 8. CG solution (top) and WG solution (bottom) for δ = 106 on Mesh 1, Mesh 3, and Mesh 5. Lin Mu WGFEM and Applications Oct 26-29, / 34

37 Summary Table of Contents 1 Weak Galerkin Finite Element Methods Motivation Implementation 2 Applications Brinkman Problems Multiscale Weak Galerkin Finite Element Methods Solution Boundedness 3 Summary and Future Work Summary Future Work Lin Mu WGFEM and Applications Oct 26-29, / 34

38 Summary Summary Summary The Weak Galerkin finite element methods provide a general framework for numerical simulation of partial differential equations. The Weak Galerkin Method employs discontinuous functions and can be performed on meshes with almost arbitrary shape. The degree of freedom of WG-FEM can be reduced efficiently by Schur complement. Simple formulation and easy implementation. Lin Mu WGFEM and Applications Oct 26-29, / 34

39 Summary Future Work Future Work Weak Galerkin simulation of electrostatics problems Domain decomposition preconditioner and parallel applications Hp adaptive of weak Galerkin finite element methods Lin Mu WGFEM and Applications Oct 26-29, / 34

40 Summary Future Work Thank you! Contact me at: Lin Mu WGFEM and Applications Oct 26-29, / 34

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

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

New class of finite element methods: weak Galerkin methods

New class of finite element methods: weak Galerkin methods New class of finite element methods: weak Galerkin methods Xiu Ye University of Arkansas at Little Rock Second order elliptic equation Consider second order elliptic problem: a u = f, in Ω (1) u = 0, on

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

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

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

Numerical Simulation of Flows in Highly Heterogeneous Porous Media

Numerical Simulation of Flows in Highly Heterogeneous Porous Media Numerical Simulation of Flows in Highly Heterogeneous Porous Media R. Lazarov, Y. Efendiev, J. Galvis, K. Shi, J. Willems The Second International Conference on Engineering and Computational Mathematics

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

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

Introduction to Aspects of Multiscale Modeling as Applied to Porous Media

Introduction to Aspects of Multiscale Modeling as Applied to Porous Media Introduction to Aspects of Multiscale Modeling as Applied to Porous Media Part IV Todd Arbogast Department of Mathematics and Center for Subsurface Modeling, Institute for Computational Engineering and

More information

Mixed Finite Element Methods. Douglas N. Arnold, University of Minnesota The 41st Woudschoten Conference 5 October 2016

Mixed Finite Element Methods. Douglas N. Arnold, University of Minnesota The 41st Woudschoten Conference 5 October 2016 Mixed Finite Element Methods Douglas N. Arnold, University of Minnesota The 41st Woudschoten Conference 5 October 2016 Linear elasticity Given the load f : Ω R n, find the displacement u : Ω R n and the

More information

Hp-Adaptivity on Anisotropic Meshes for Hybridized Discontinuous Galerkin Scheme

Hp-Adaptivity on Anisotropic Meshes for Hybridized Discontinuous Galerkin Scheme Hp-Adaptivity on Anisotropic Meshes for Hybridized Discontinuous Galerkin Scheme Aravind Balan, Michael Woopen and Georg May AICES Graduate School, RWTH Aachen University, Germany 22nd AIAA Computational

More information

Stochastic multiscale modeling of subsurface and surface flows. Part III: Multiscale mortar finite elements for coupled Stokes-Darcy flows

Stochastic multiscale modeling of subsurface and surface flows. Part III: Multiscale mortar finite elements for coupled Stokes-Darcy flows Stochastic multiscale modeling of subsurface and surface flows. Part III: Multiscale mortar finite elements for coupled Stokes-Darcy flows Ivan otov Department of Mathematics, University of Pittsburgh

More information

arxiv: v1 [math.na] 25 Aug 2016

arxiv: v1 [math.na] 25 Aug 2016 A conservative local multiscale model reduction technique for Stoes flows in heterogeneous perforated domains Eric T. Chung Maria Vasilyeva Yating Wang arxiv:1608.07268v1 [math.na] 25 Aug 2016 October

More information

A FAMILY OF MULTISCALE HYBRID-MIXED FINITE ELEMENT METHODS FOR THE DARCY EQUATION WITH ROUGH COEFFICIENTS. 1. Introduction

A FAMILY OF MULTISCALE HYBRID-MIXED FINITE ELEMENT METHODS FOR THE DARCY EQUATION WITH ROUGH COEFFICIENTS. 1. Introduction A FAMILY OF MULTISCALE HYBRID-MIXED FINITE ELEMENT METHODS FOR THE DARCY EQUATION WITH ROUGH COEFFICIENTS CHRISTOPHER HARDER, DIEGO PAREDES 2, AND FRÉDÉRIC VALENTIN Abstract. We aim at proposing novel

More information

arxiv: v1 [math.na] 4 Jun 2014

arxiv: v1 [math.na] 4 Jun 2014 MIXE GENERALIZE MULTISCALE FINITE ELEMENT METHOS AN APPLICATIONS ERIC T. CHUNG, YALCHIN EFENIEV, AN CHA SHING LEE arxiv:1406.0950v1 [math.na] 4 Jun 2014 Abstract. In this paper, we present a mixed Generalized

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

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

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

Online basis construction for goal-oriented adaptivity in the Generalized Multiscale Finite Element Method

Online basis construction for goal-oriented adaptivity in the Generalized Multiscale Finite Element Method Online basis construction for goal-oriented adaptivity in the Generalized Multiscale Finite Element Method Eric Chung, Sara Pollock, Sai-Mang Pun arxiv:1812.02290v1 [math.na] 6 Dec 2018 December 7, 2018

More information

arxiv: v1 [math.na] 11 Jul 2011

arxiv: v1 [math.na] 11 Jul 2011 Multigrid Preconditioner for Nonconforming Discretization of Elliptic Problems with Jump Coefficients arxiv:07.260v [math.na] Jul 20 Blanca Ayuso De Dios, Michael Holst 2, Yunrong Zhu 2, and Ludmil Zikatanov

More information

Finite Element Multigrid Framework for Mimetic Finite Difference Discretizations

Finite Element Multigrid Framework for Mimetic Finite Difference Discretizations Finite Element Multigrid Framework for Mimetic Finite ifference iscretizations Xiaozhe Hu Tufts University Polytopal Element Methods in Mathematics and Engineering, October 26-28, 2015 Joint work with:

More information

Preconditioned space-time boundary element methods for the heat equation

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

More information

Discontinuous Galerkin Method for interface problem of coupling different order elliptic equations

Discontinuous Galerkin Method for interface problem of coupling different order elliptic equations Discontinuous Galerkin Method for interface problem of coupling different order elliptic equations Igor Mozolevski, Endre Süli Federal University of Santa Catarina, Brazil Oxford University Computing Laboratory,

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

Outline: 1 Motivation: Domain Decomposition Method 2 3 4

Outline: 1 Motivation: Domain Decomposition Method 2 3 4 Multiscale Basis Functions for Iterative Domain Decomposition Procedures A. Francisco 1, V. Ginting 2, F. Pereira 3 and J. Rigelo 2 1 Department Mechanical Engineering Federal Fluminense University, Volta

More information

IFE for Stokes interface problem

IFE for Stokes interface problem IFE for Stokes interface problem Nabil Chaabane Slimane Adjerid, Tao Lin Virginia Tech SIAM chapter February 4, 24 Nabil Chaabane (VT) IFE for Stokes interface problem February 4, 24 / 2 Problem statement

More information

A Review of Preconditioning Techniques for Steady Incompressible Flow

A Review of Preconditioning Techniques for Steady Incompressible Flow Zeist 2009 p. 1/43 A Review of Preconditioning Techniques for Steady Incompressible Flow David Silvester School of Mathematics University of Manchester Zeist 2009 p. 2/43 PDEs Review : 1984 2005 Update

More information

Two new enriched multiscale coarse spaces for the Additive Average Schwarz method

Two new enriched multiscale coarse spaces for the Additive Average Schwarz method 346 Two new enriched multiscale coarse spaces for the Additive Average Schwarz method Leszek Marcinkowski 1 and Talal Rahman 2 1 Introduction We propose additive Schwarz methods with spectrally enriched

More information

Preconditioners for the incompressible Navier Stokes equations

Preconditioners for the incompressible Navier Stokes equations Preconditioners for the incompressible Navier Stokes equations C. Vuik M. ur Rehman A. Segal Delft Institute of Applied Mathematics, TU Delft, The Netherlands SIAM Conference on Computational Science and

More information

A C 1 virtual element method for the Cahn-Hilliard equation with polygonal meshes. Marco Verani

A C 1 virtual element method for the Cahn-Hilliard equation with polygonal meshes. Marco Verani A C 1 virtual element method for the Cahn-Hilliard equation with polygonal meshes Marco Verani MOX, Department of Mathematics, Politecnico di Milano Joint work with: P. F. Antonietti (MOX Politecnico di

More information

A Posteriori Error Estimates for Weak Galerkin Finite Element Methods for Second Order Elliptic Problems

A Posteriori Error Estimates for Weak Galerkin Finite Element Methods for Second Order Elliptic Problems DOI 10.1007/s10915-013-9771-3 A Posteriori Error Estimates for Weak Galerkin Finite Element Methods for Second Order Elliptic Problems Long Chen Junping Wang Xiu Ye Received: 29 January 2013 / Revised:

More information

Solving PDEs with Multigrid Methods p.1

Solving PDEs with Multigrid Methods p.1 Solving PDEs with Multigrid Methods Scott MacLachlan maclachl@colorado.edu Department of Applied Mathematics, University of Colorado at Boulder Solving PDEs with Multigrid Methods p.1 Support and Collaboration

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

Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses

Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses P. Boyanova 1, I. Georgiev 34, S. Margenov, L. Zikatanov 5 1 Uppsala University, Box 337, 751 05 Uppsala,

More information

ASM-BDDC Preconditioners with variable polynomial degree for CG- and DG-SEM

ASM-BDDC Preconditioners with variable polynomial degree for CG- and DG-SEM ASM-BDDC Preconditioners with variable polynomial degree for CG- and DG-SEM C. Canuto 1, L. F. Pavarino 2, and A. B. Pieri 3 1 Introduction Discontinuous Galerkin (DG) methods for partial differential

More information

Nonparametric density estimation for elliptic problems with random perturbations

Nonparametric density estimation for elliptic problems with random perturbations Nonparametric density estimation for elliptic problems with random perturbations, DqF Workshop, Stockholm, Sweden, 28--2 p. /2 Nonparametric density estimation for elliptic problems with random perturbations

More information

The Conjugate Gradient Method

The Conjugate Gradient Method The Conjugate Gradient Method Classical Iterations We have a problem, We assume that the matrix comes from a discretization of a PDE. The best and most popular model problem is, The matrix will be as large

More information

Uniform inf-sup condition for the Brinkman problem in highly heterogeneous media

Uniform inf-sup condition for the Brinkman problem in highly heterogeneous media Uniform inf-sup condition for the Brinkman problem in highly heterogeneous media Raytcho Lazarov & Aziz Takhirov Texas A&M May 3-4, 2016 R. Lazarov & A.T. (Texas A&M) Brinkman May 3-4, 2016 1 / 30 Outline

More information

Problem C3.5 Direct Numerical Simulation of the Taylor-Green Vortex at Re = 1600

Problem C3.5 Direct Numerical Simulation of the Taylor-Green Vortex at Re = 1600 Problem C3.5 Direct Numerical Simulation of the Taylor-Green Vortex at Re = 6 Overview This problem is aimed at testing the accuracy and the performance of high-order methods on the direct numerical simulation

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

Divergence-conforming multigrid methods for incompressible flow problems

Divergence-conforming multigrid methods for incompressible flow problems Divergence-conforming multigrid methods for incompressible flow problems Guido Kanschat IWR, Universität Heidelberg Prague-Heidelberg-Workshop April 28th, 2015 G. Kanschat (IWR, Uni HD) Hdiv-DG Práha,

More information

MATH 676. Finite element methods in scientific computing

MATH 676. Finite element methods in scientific computing MATH 676 Finite element methods in scientific computing Wolfgang Bangerth, Texas A&M University Lecture 33.25: Which element to use Part 2: Saddle point problems Consider the stationary Stokes equations:

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

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

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

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

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

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

Numerical Analysis of Differential Equations Numerical Solution of Elliptic Boundary Value

Numerical Analysis of Differential Equations Numerical Solution of Elliptic Boundary Value Numerical Analysis of Differential Equations 188 5 Numerical Solution of Elliptic Boundary Value Problems 5 Numerical Solution of Elliptic Boundary Value Problems TU Bergakademie Freiberg, SS 2012 Numerical

More information

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid Solving the Stochastic Steady-State Diffusion Problem Using Multigrid Tengfei Su Applied Mathematics and Scientific Computing Advisor: Howard Elman Department of Computer Science Sept. 29, 2015 Tengfei

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

arxiv: v1 [math.na] 5 Jun 2018

arxiv: v1 [math.na] 5 Jun 2018 PRIMAL-DUAL WEAK GALERKIN FINIE ELEMEN MEHODS FOR ELLIPIC CAUCHY PROBLEMS CHUNMEI WANG AND JUNPING WANG arxiv:1806.01583v1 [math.na] 5 Jun 2018 Abstract. he authors propose and analyze a well-posed numerical

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

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

Is My CFD Mesh Adequate? A Quantitative Answer

Is My CFD Mesh Adequate? A Quantitative Answer Is My CFD Mesh Adequate? A Quantitative Answer Krzysztof J. Fidkowski Gas Dynamics Research Colloqium Aerospace Engineering Department University of Michigan January 26, 2011 K.J. Fidkowski (UM) GDRC 2011

More information

FREE BOUNDARY PROBLEMS IN FLUID MECHANICS

FREE BOUNDARY PROBLEMS IN FLUID MECHANICS FREE BOUNDARY PROBLEMS IN FLUID MECHANICS ANA MARIA SOANE AND ROUBEN ROSTAMIAN We consider a class of free boundary problems governed by the incompressible Navier-Stokes equations. Our objective is to

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 Petrov-Galerkin Enriched Method: A Mass Conservative Finite Element Method For The Darcy Equation

A Petrov-Galerkin Enriched Method: A Mass Conservative Finite Element Method For The Darcy Equation University of Colorado at Denver and Health Sciences Center A Petrov-Galerkin Enriched Method: A Mass Conservative Finite Element Method For The Darcy Equation Gabriel R. Barrenechea, Leopoldo P. Franca,

More information

A Multiscale Hybrid-Mixed method for the elastodynamic model in time domain

A Multiscale Hybrid-Mixed method for the elastodynamic model in time domain 1/21 A Multiscale Hybrid-Mixed method for the elastodynamic model in time domain Weslley da Silva Pereira 1 Nachos project-team, Inria Sophia Antipolis - Mediterranée (FR) Inria Sophia Antipolis - Mediterranée

More information

MULTISCALE FINITE ELEMENT METHODS FOR NONLINEAR PROBLEMS AND THEIR APPLICATIONS

MULTISCALE FINITE ELEMENT METHODS FOR NONLINEAR PROBLEMS AND THEIR APPLICATIONS MULTISCALE FINITE ELEMENT METHODS FOR NONLINEAR PROBLEMS AND THEIR APPLICATIONS Y. EFENDIEV, T. HOU, AND V. GINTING Abstract. In this paper we propose a generalization of multiscale finite element methods

More information

Hybridized DG methods

Hybridized DG methods Hybridized DG methods University of Florida (Banff International Research Station, November 2007.) Collaborators: Bernardo Cockburn University of Minnesota Raytcho Lazarov Texas A&M University Thanks:

More information

Une méthode de pénalisation par face pour l approximation des équations de Navier-Stokes à nombre de Reynolds élevé

Une méthode de pénalisation par face pour l approximation des équations de Navier-Stokes à nombre de Reynolds élevé Une méthode de pénalisation par face pour l approximation des équations de Navier-Stokes à nombre de Reynolds élevé CMCS/IACS Ecole Polytechnique Federale de Lausanne Erik.Burman@epfl.ch Méthodes Numériques

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

Stabilization and Acceleration of Algebraic Multigrid Method

Stabilization and Acceleration of Algebraic Multigrid Method Stabilization and Acceleration of Algebraic Multigrid Method Recursive Projection Algorithm A. Jemcov J.P. Maruszewski Fluent Inc. October 24, 2006 Outline 1 Need for Algorithm Stabilization and Acceleration

More information

Spline Element Method for Partial Differential Equations

Spline Element Method for Partial Differential Equations for Partial Differential Equations Department of Mathematical Sciences Northern Illinois University 2009 Multivariate Splines Summer School, Summer 2009 Outline 1 Why multivariate splines for PDEs? Motivation

More information

Weierstraß-Institut. für Angewandte Analysis und Stochastik. im Forschungsverbund Berlin e.v. Preprint ISSN

Weierstraß-Institut. für Angewandte Analysis und Stochastik. im Forschungsverbund Berlin e.v. Preprint ISSN Weierstraß-Institut für Angewandte Analysis und Stochastik im Forschungsverbund Berlin e.v. Preprint ISSN 946 8633 Computational comparison between the Taylor Hood and the conforming Crouzeix Raviart element

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

Numerical lower bounds on eigenvalues of elliptic operators

Numerical lower bounds on eigenvalues of elliptic operators Numerical lower bounds on eigenvalues of elliptic operators Tomáš Vejchodský (vejchod@math.cas.cz) Institute of Mathematics Czech Academy of Sciences INSTITUTEofMATHEMATICS Czech Academy of Sciences EMS

More information

DELFT UNIVERSITY OF TECHNOLOGY

DELFT UNIVERSITY OF TECHNOLOGY DELFT UNIVERSITY OF TECHNOLOGY REPORT 12-10 Fast linear solver for pressure computation in layered domains P. van Slingerland and C. Vuik ISSN 1389-6520 Reports of the Department of Applied Mathematical

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

Parallel Discontinuous Galerkin Method

Parallel Discontinuous Galerkin Method Parallel Discontinuous Galerkin Method Yin Ki, NG The Chinese University of Hong Kong Aug 5, 2015 Mentors: Dr. Ohannes Karakashian, Dr. Kwai Wong Overview Project Goal Implement parallelization on Discontinuous

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

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

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 Numerical Methods for Partial Differential Equations Finite Difference Methods

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

arxiv: v2 [math.na] 20 May 2016

arxiv: v2 [math.na] 20 May 2016 GEOMETRIC MULTIGRID FOR DARCY AND BRINKMAN MODELS OF FLOWS IN HIGHLY HETEROGENEOUS POROUS MEDIA: A NUMERICAL STUDY arxiv:1602.04858v2 [math.na] 20 May 2016 GUIDO KANSCHAT, RAYTCHO LAZAROV, AND YOULI MAO

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

Computer simulation of multiscale problems

Computer simulation of multiscale problems Progress in the SSF project CutFEM, Geometry, and Optimal design Computer simulation of multiscale problems Axel Målqvist and Daniel Elfverson University of Gothenburg and Uppsala University Umeå 2015-05-20

More information

To CG or to HDG: A Comparative Study

To CG or to HDG: A Comparative Study To CG or to HDG: A Comparative Study Robert M. Kirby a,1, Spencer J. Sherwin b,3 Bernardo Cockburn c,2, a School of Computing, Univ. of Utah, Salt Lake City, UT, USA b Department of Aeronautics, Imperial

More information

The Plane Stress Problem

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

More information

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

Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms

Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms Marcus Sarkis Worcester Polytechnic Inst., Mass. and IMPA, Rio de Janeiro and Daniel

More information

The CG1-DG2 method for conservation laws

The CG1-DG2 method for conservation laws for conservation laws Melanie Bittl 1, Dmitri Kuzmin 1, Roland Becker 2 MoST 2014, Germany 1 Dortmund University of Technology, Germany, 2 University of Pau, France CG1-DG2 Method - Motivation hp-adaptivity

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

Time-dependent Dirichlet Boundary Conditions in Finite Element Discretizations

Time-dependent Dirichlet Boundary Conditions in Finite Element Discretizations Time-dependent Dirichlet Boundary Conditions in Finite Element Discretizations Peter Benner and Jan Heiland November 5, 2015 Seminar Talk at Uni Konstanz Introduction Motivation A controlled physical processes

More information

Multiscale methods for time-harmonic acoustic and elastic wave propagation

Multiscale methods for time-harmonic acoustic and elastic wave propagation Multiscale methods for time-harmonic acoustic and elastic wave propagation Dietmar Gallistl (joint work with D. Brown and D. Peterseim) Institut für Angewandte und Numerische Mathematik Karlsruher Institut

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

Finite Element Clifford Algebra: A New Toolkit for Evolution Problems

Finite Element Clifford Algebra: A New Toolkit for Evolution Problems Finite Element Clifford Algebra: A New Toolkit for Evolution Problems Andrew Gillette joint work with Michael Holst Department of Mathematics University of California, San Diego http://ccom.ucsd.edu/ agillette/

More information

Implementation of Sparse Wavelet-Galerkin FEM for Stochastic PDEs

Implementation of Sparse Wavelet-Galerkin FEM for Stochastic PDEs Implementation of Sparse Wavelet-Galerkin FEM for Stochastic PDEs Roman Andreev ETH ZÜRICH / 29 JAN 29 TOC of the Talk Motivation & Set-Up Model Problem Stochastic Galerkin FEM Conclusions & Outlook Motivation

More information

A Posteriori Error Estimates For Discontinuous Galerkin Methods Using Non-polynomial Basis Functions

A Posteriori Error Estimates For Discontinuous Galerkin Methods Using Non-polynomial Basis Functions Lin Lin A Posteriori DG using Non-Polynomial Basis 1 A Posteriori Error Estimates For Discontinuous Galerkin Methods Using Non-polynomial Basis Functions Lin Lin Department of Mathematics, UC Berkeley;

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

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

Algebraic Multigrid as Solvers and as Preconditioner

Algebraic Multigrid as Solvers and as Preconditioner Ò Algebraic Multigrid as Solvers and as Preconditioner Domenico Lahaye domenico.lahaye@cs.kuleuven.ac.be http://www.cs.kuleuven.ac.be/ domenico/ Department of Computer Science Katholieke Universiteit Leuven

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

Additive Average Schwarz Method for a Crouzeix-Raviart Finite Volume Element Discretization of Elliptic Problems

Additive Average Schwarz Method for a Crouzeix-Raviart Finite Volume Element Discretization of Elliptic Problems Additive Average Schwarz Method for a Crouzeix-Raviart Finite Volume Element Discretization of Elliptic Problems Atle Loneland 1, Leszek Marcinkowski 2, and Talal Rahman 3 1 Introduction In this paper

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

MULTISCALE FINITE ELEMENT METHODS FOR NONLINEAR PROBLEMS AND THEIR APPLICATIONS

MULTISCALE FINITE ELEMENT METHODS FOR NONLINEAR PROBLEMS AND THEIR APPLICATIONS COMM. MATH. SCI. Vol. 2, No. 4, pp. 553 589 c 2004 International Press MULTISCALE FINITE ELEMENT METHODS FOR NONLINEAR PROBLEMS AND THEIR APPLICATIONS Y. EFENDIEV, T. HOU, AND V. GINTING Abstract. In this

More information