On some numerical convergence studies of mixed finite element methods for flow in porous media

Size: px
Start display at page:

Download "On some numerical convergence studies of mixed finite element methods for flow in porous media"

Transcription

1 On some numerical convergence studies of mixed finite element methods for flow in porous media Gergina Pencheva Abstract We consider an expanded mixed finite element method for solving second-order elliptic partial differential equations. We study the effects of nonmatching grids, discontinuous coefficients, and high variation in the coefficients on the accuracy of the numerical solution. The error in the case of nonmatching grids and smooth solutions occurs mainly along the interfaces and high accuracy is preserved in the interior. Discontinuous coefficients may lead to singular solutions and the polution from the singularity affects the accuracy in the whole domain. Our last set of examples shows that the dependence of the convergence rates and constants in front of the error terms on high variation in the coefficients is very weak. 1 Introduction In this work we consider mixed finite element method for subdomain discretizations. Mixed methods owe their popularity to their local (element-wise) mass conservation property and the simultaneous and accurate approximation of two variables of physical interest, e.g., pressure and velocity in fluid flow. In many applications the complexity of the geometry or the behavior of the solution prompts the use of multiblock domain structure where the simulation domain is decomposed into a series of nonoverlapping subdomains (blocks). Each block is independently covered by a local grid. A non-overlpping domain decomposition algorithm was developed for matching grids by Glowinski and Wheeler [5, 3] ans was later extended to non-matching grids. Mortar finite elements are used to impose physically meaningfull matching conditions on the interfaces while mixed finite elements are applied locally on the subdomains (see [6, 1] for details). In this work we consider a second-order elliptic equation which in porous medium applications models single phase Darsy flow. We solve for the pressure p and the velocity field u satisfying u = K p in Ω, (1) u + αp = f in Ω, (2) p = g D on Γ D, (3) u ν = g N on Γ N, (4) where α 0 represents the rock compressibility; Ω R d, d = 2 or 3 is a multiblock domain; K is symmetric, uniformly positive definite tensor with smooth or perhaps piecewise smooth components representing the permeability divided by the viscosity; ν is outward unit normal vector on Ω; and Ω is decomposed into Γ D and Γ N. The problem was solved using the parallel domain decomposition code Parcel [4] with some modifications made by the author. The code implements an expanded mixed finite element method developed by Arbogast, Wheeler and Yotov [2] where mixed method with tensor coefficient is writen as a cell-centered finite difference method by incorporating certain quadrature rules. In the case of nonmatching grids we study the convergence of interior velocity (far from subdomain interfaces). The results show that the interior velocity error is superconvergent of O(h 2 ), which means that majority 1

2 of the error occurs near the interfaces. Therefore we need to apply some local postprocessing to obtain better convergence rate for the velocity error. Second group of tests was run in the case of discontinuous tensor for both mathing and nonmatching grids. As the results show, because of the strong singularity at the cross-point (1/2, 1/2), there is no superconvergence even in the interior. The maximum rate of convergence for the interior velocity error is of O(h). Therefore to control the error we need some local refinement near this cross-point. Analyzing all test results in group 1 and group 2 we may conclude that interior velocity error depends on the smoothness of the solution in the whole domain Ω, but in a more weak sense, and that interior velocity error is better than the velocity error calculated over the whole domain. The last group of tests studies the influence of the the low order term α in (2) on the constant C in the error estimate p p h Ch 2. We compared the results when α = 0 (no low order term) and α = 1. The results show that this method works very well for both cases even if there are big variations of K and that the constant increases very slowly when the ratio goes up. The rest of the paper is organized as follows. Interior error estimates in the case of nonmatching grids are presented in Section 2. Error estimates in the case of discontinuous tensor are presented in Section 3. In section 4 the influence of the low order term on the constant in the error estimates is studied. 2 Interior error estimates in the case of nonmatching grids To study the interior velocity error we used six tests with known analytic solutions. All examples are on the unit cube. The domain is divided into four subdomains with interfaces along the x = 1/2 and y = 1/2 lines. The boundary conditions are Dirichlet on the left and right face and Neumann on the rest of the boundary. In test#58 we have p(x, y, z) = x 3 y 2 + sin(xy) and K = cos(xy) In test#59 p(x, y, z) = cos( πx 2 ) cos(πy ) and K = I. 2 In test#64 we have a problem with discontinuous coefficient { I, 0 x < 1/2 K = 10 I, 1/2 < x 1. The solution x 2 y 3 + cos(xy), 0 x < 1/2 p(x, y, z) = ( ) 2x y 3 + cos( 2x+9 20 y), 1/2 < x 1 is chosen to be continuous and to have continuous normal flux at x = 1/2. In the next three tests K is a full tensor. In test#104 In test#107 p(x, y, z) = x + y + z 1.5 and K =. x 2 + y z sin(xy) 0 sin(xy) x 2 y p(x, y, z) = x 2 (x 1) 2 y 2 (y 1) 2 z 2 (z 1) 2 and K =

3 Finally in test#110 and { xy, 0 x 1/2 p(x, y, z) = xy + (x 1/2)(y + 1/2), 1/2 x , 0 x < 1/2 K = I, 1/2 < x 1 For the 2d-problems (## 58, 59, 64, 110) the initial nonmatching grids are given in Figure 1 and the initial mortar grids on all interfaces are given in Table 1. For 3d-problems (#104, #107) we consider similar (but 3d ) grids. We use α = 0.1. Figure 1: Initial non-matching grids for Cases 1 3 mortar elements Table 1: Initial number of elements in mortar grids for Cases Case 1 The code was first modified to calculate the error over the interiors of all subdomains that have a one-element border around it. Tests were only run using mortar 4 (piecewise constant) because it was obvious that even there exist some improvement of the the rate of convergence of the interior error, it is not essential. The results for this case are in Table 2. The rates were established by running all tests for 5 levels of grid refinement (we halve the element diameters for each refinement) and computing a least squares fit to the error. 2.2 Case 2 The second modification of the code produced a scaled interior error. The calculation u u h / u over the interior subdomains was used in an attempt to eliminate any possible influence in the size of the interior subdomains would have on the error calculations. Again the improvement wasn t essential. The results for this case are in Table 3. 3

4 velocity L 2 error vel. L 2 err. Int. velocity L error vel. L err. Int. test C u α u C u α u C u α u C u α u Table 2: Velocity errors for Case 1 mortar 4 mor velocity L 2 error vel. L 2 err. Int. velocity L error vel. L err. Int. tar test C u α u C u α u C u α u C u α u Table 3: Velocity errors for Case 2 4

5 2.3 Case 3 Thirdly, the code was modified to calculate the errors over fixed interior domains for each level of refinement. In this case it seems that the interior velocity error is superconvergent of O(h 2 ), which means that majority of the error occurs near the interfaces. Therefore we need to apply some local postprocessing to obtain better convergence rate for the velocity error. The results for this case are in Table 4 and Table 5. Plots of the computed solution and the numerical error for the case of mortar 4 are shown in Figure 2 through Figure 7. mor flux error pressure L 2 error λ error tar test C f α f C p α p C λ α λ Table 4: Velocity errors for Case 3 Part I 5

6 mor velocity L 2 error vel. L 2 err. Int. velocity L error vel. L err. Int. tar test C u α u C u α u C u α u C u α u Table 5: Velocity errors for Case 3 Part II 6

7 A. Computed pressure and velocity B. Pressure and velocity error Figure 2: Solution and error (magnified) for test#58 mortar4 A. Computed pressure and velocity B. Pressure and velocity error Figure 3: Solution and error (magnified) for test#59 mortar4 7

8 A. Computed pressure and velocity B. Pressure and velocity error Figure 4: Solution and error (magnified) for test#64 mortar4 A. Computed pressure and velocity B. Pressure and velocity error Figure 5: Solution and error (magnified) for test#104 mortar4 8

9 A. Computed pressure and velocity B. Pressure and velocity error Figure 6: Solution and error (magnified) for test#107 mortar4 A. Computed pressure and velocity B. Pressure and velocity error Figure 7: Solution and error (magnified) for test#110 mortar4 9

10 3 Error estimates in the case of discontinuous tensor Because it is hard to find problems with discontinuous tensor and known true solution for which the right-hand side f is a smooth function, we needed to make a bigger modification in the code. Thus, first the code was run for the finest grid and the solution was saved in files. Then the stored solution from this initial run was used to calculate the errors for all coarser grids. Again all examples are on the unit cube; the domain was divided into four equal subdomains. The initial grid in the case of matching grids was chosen to be The initial nonmatching and mortar grids are shown in Table Non-matching grids Table 6: Initial grids for Case 4 mortar elements Mortar grids In this case different test problems were tested. In problems 70 through 75 the permeability tensors were diagonal with piecewise constant diagonal elements. The prototype for the permeability tensor is K = a(x, y) a(x, y) a(x, y) where 10 n, if x < 1/2, y < 1/2 a(x, y) = 10 n, if x > 1/2, y > 1/2 1, otherwise For test problem#70,n = 1 and then n increments by 1 with each test problem through test#73. problem# , x < 1/2, y < 1/2 a(x, y) = 10, x > 1/2, y > 1/2 1, otherwise For test problem#75 10, x < 1/2, y < 1/2 a(x, y) = 10 2, x > 1/2, y > 1/2 1, otherwise Test problem#170 is with full tensor a(x, y).1a(x, y) 0 K =.1a(x, y) a(x, y) a(x, y) For test where a(x, y) is as in test problem#70. The boundary conditions are Dirichlet on the left and right face and Neumann (no flow) on the rest of the boundary. For test problems#70,#71,#72, #73,#170 p x=0 = 1 while for test problems#74 and #75 p x=0 = 10 10

11 For all tests p x=1 = 0 The results for this case are in Table 7 and Table 8. Plots of the computed solution and the numerical error for test problems#71 and #170 are shown in Figure 8 and Figure 9. As the results show, because of the strong singularity at the cross-point (1/2, 1/2), there is no superconvergence even in the interior. The maximum rate of convergence for the interior velocity error is of O(h). Therefore to control the error we need some local refinement near this cross-point. Conclusion:Analyzing all test results in Section 2 and Section 3 we may conclude that interior velocity error depends on the smoothness of the solution in the whole domain Ω, but in more weak sense, and that interior velocity error is better than the velocity error calculated over the whole domain. mortar 4 mortar 3 mortar 2 mortar 1 matching grids flux error pressure L 2 error λ error test C f α f C p α p C λ α λ Table 7: Errors for Case 4 Part I 11

12 mortar 4 mortar 3 mortar 2 mortar 1 matching grids velocity L 2 error vel. L 2 err. Int. velocity L error vel. L err. Int. test C u α u C u α u C u α u C u α u Table 8: Errors for Case 4 Part II 12

13 A. Computed pressure and velocity B. Pressure and velocity error Figure 8: Solution and error (magnified) for test#71 matching grids A. Computed pressure and velocity B. Pressure and velocity error Figure 9: Solution and error (magnified) for test#170 matching grids 13

14 4 Influence of the low order term on the constant in the error estimates Theory indicates that the constant C in the error estimate p p h Ch 2 depends on K max /K min. We study the dependence of the constant on the low order term α in (2). We tested three groups of problems. For all of them the permeability tensor K was chosen to be diagonal matrix with diagonal elements a(x) = e β(x 1 2 )2 where β is a real, nonnegative parameter. The values of β and corresponding values (approximately) of the ratio K max /K min are given in Table 9. β ratio Table 9: Values of Kmax K min Test problems#81 and #82 used true analytic solutions. For test#81 p = 1 x and for test#82 p = x 3 y 4 + x 2 + sin(xy) cos(y) For test#83 we used again files to save the solution for the finest grid. For this test f 0, p x=0 = 1, p x=1 = 0 and u ν = 0 on Γ N. For all test problems we used matching grids and the boundary conditions were Dirichlet on the left and right face and Neumann on the rest of the boundary. We compared the results when α = 0 (no low order term) and α = 1. The results are in Table 10 through Table 15.. Plots of the computed solution and the numerical error for α = 0 and α = 1 are shown in Figure 10 through Figure 15. They show that this method works very well for both cases even if there are big variations of K and that the constant increases very slowly when the ratio goes up. flux error pressure L 2 error λ error α C f α f C p α p C λ α λ E E E E E E ratio Table 10: Errors for Test#81 Part I 14

15 velocity L 2 error vel. L 2 err. Int. velocity L error vel. L err. Int. α C u α u C u α u C u α u C u α u E E E E E E E E ratio Table 11: Errors for Test#81 Part II flux error pressure L 2 error λ error ratio α C f α f C p α p C λ α λ Table 12: Errors for Test#82 Part I velocity L 2 error vel. L 2 err. Int. velocity L error vel. L err. Int. ratio α C u α u C u α u C u α u C u α u Table 13: Errors for Test#82 Part II 15

16 flux error pressure L 2 error λ error ratio α C f α f C p α p C λ α λ E E E E E E Table 14: Errors for Test#83 Part I velocity L 2 error vel. L 2 err. Int. velocity L error vel. L err. Int. ratio α C u α u C u α u C u α u C u α u E E E E E E E E Table 15: Errors for Test#83 Part II A. Computed pressure and velocity B. Pressure and velocity error Figure 10: Solution and error (magnified) for test#81 α = 0 β = 46 matching grids 16

17 A. Computed pressure and velocity B. Pressure and velocity error Figure 11: Solution and error (magnified) for test#81 α = 1 β = 46 matching grids A. Computed pressure and velocity B. Pressure and velocity error Figure 12: Solution and error (magnified) for test#82 α = 0 β = 46 matching grids 17

18 A. Computed pressure and velocity B. Pressure and velocity error Figure 13: Solution and error (magnified) for test#82 α = 1 β = 46 matching grids A. Computed pressure and velocity B. Pressure and velocity error Figure 14: Solution and error (magnified) for test#83 α = 0 β = 46 matching grids 18

19 References A. Computed pressure and velocity B. Pressure and velocity error Figure 15: Solution and error (magnified) for test#83 α = 1 β = 46 matching grids [1] T. ARBOGAST, L. C. COWSAR, M. F. WHEELER, AND I. YOTOV, Mixed finite element methods on nonmatching multiblock grids, SIAM J. Numer. Anal., 37 (2000), pp [2] T. ARBOGAST, M. F. WHEELER, AND I. YOTOV, Mixed finite elements for elliptic problems with tensor coefficients as cell-centered finite differences, SIAM J. Numer. Anal., 34 (1997), pp [3] L C. COWSAR AND M. F. WHEELER, Parallel domain decomposition method for mixed finite elements for elliptic partial differential equations, in Fourth International Symposium on Domain Decomposition Methods for Partial Differential Equations, SIAM, Philadelphia, [4] L C. COWSAR, C A. SAN SOUCIE, AND I YOTOV, Parcel v1.04 User Guide, May [5] R. GLOWINSKI AND M. F. WHEELER, Domain decomposition and mixed finite element methods for elliptic problems, in First International Symposium on Domain Decomposition Methods for Partial Differential Equations, SIAM, Philadelphia, 1988, pp [6] I. YOTOV, Mixed finite element methods for flow in porous media, PhD Thesis, Rice University, Houston, Texas. TR96-09, Dept. Comp. Appl. Math., Rice University and TICAM report 96-23, University of Texas at Austin. 19

Interior superconvergence in mortar and non-mortar mixed finite element methods on non-matching grids

Interior superconvergence in mortar and non-mortar mixed finite element methods on non-matching grids Interior superconvergence in mortar and non-mortar mixed finite element methods on non-matching grids Gergina Pencheva a,, Ivan Yotov b a Center for Subsurface Modeling, Institute for Computational Engineering

More information

2 IVAN YOTOV decomposition solvers and preconditioners are described in Section 3. Computational results are given in Section Multibloc formulat

2 IVAN YOTOV decomposition solvers and preconditioners are described in Section 3. Computational results are given in Section Multibloc formulat INTERFACE SOLVERS AND PRECONDITIONERS OF DOMAIN DECOMPOSITION TYPE FOR MULTIPHASE FLOW IN MULTIBLOCK POROUS MEDIA IVAN YOTOV Abstract. A multibloc mortar approach to modeling multiphase ow in porous media

More information

Physical and Computational Domain Decompositions for Modeling Subsurface Flows

Physical and Computational Domain Decompositions for Modeling Subsurface Flows Contemporary Mathematics Physical and Computational Domain Decompositions for Modeling Subsurface Flows Mary F. Wheeler and Ivan Yotov 1. Introduction Modeling of multiphase flow in permeable media plays

More information

Balancing domain decomposition for mortar mixed nite element methods

Balancing domain decomposition for mortar mixed nite element methods NUMERICAL LINEAR ALGEBRA WITH APPLICATIONS Numer. Linear Algebra Appl. 2003; 10:159 180 (DOI: 10.1002/nla.316) Balancing domain decomposition for mortar mixed nite element methods Gergina Pencheva and

More information

Texas at Austin 2 Nazarbayev University. January 15, 2019

Texas at Austin 2 Nazarbayev University. January 15, 2019 Recovery of the Interface Velocity for the Incompressible Flow in Enhanced Velocity Mixed Finite Element Method arxiv:1901.04401v1 [math.na] 14 Jan 2019 Yerlan Amanbek 1,2, Gurpreet Singh 1, and Mary F.

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

A MULTIGRID ALGORITHM FOR. Richard E. Ewing and Jian Shen. Institute for Scientic Computation. Texas A&M University. College Station, Texas SUMMARY

A MULTIGRID ALGORITHM FOR. Richard E. Ewing and Jian Shen. Institute for Scientic Computation. Texas A&M University. College Station, Texas SUMMARY A MULTIGRID ALGORITHM FOR THE CELL-CENTERED FINITE DIFFERENCE SCHEME Richard E. Ewing and Jian Shen Institute for Scientic Computation Texas A&M University College Station, Texas SUMMARY In this article,

More information

Parallel Simulation of Subsurface Fluid Flow

Parallel Simulation of Subsurface Fluid Flow Parallel Simulation of Subsurface Fluid Flow Scientific Achievement A new mortar domain decomposition method was devised to compute accurate velocities of underground fluids efficiently using massively

More information

A Nonoverlapping Subdomain Algorithm with Lagrange Multipliers and its Object Oriented Implementation for Interface Problems

A Nonoverlapping Subdomain Algorithm with Lagrange Multipliers and its Object Oriented Implementation for Interface Problems Contemporary Mathematics Volume 8, 998 B 0-88-0988--03030- A Nonoverlapping Subdomain Algorithm with Lagrange Multipliers and its Object Oriented Implementation for Interface Problems Daoqi Yang. Introduction

More information

A Multiscale Mortar Method And Two-Stage Preconditioner For Multiphase Flow Using A Global Jacobian Approach

A Multiscale Mortar Method And Two-Stage Preconditioner For Multiphase Flow Using A Global Jacobian Approach SPE-172990-MS A Multiscale Mortar Method And Two-Stage Preconditioner For Multiphase Flow Using A Global Jacobian Approach Benjamin Ganis, Kundan Kumar, and Gergina Pencheva, SPE; Mary F. Wheeler, The

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 multiscale preconditioner for stochastic mortar mixed finite elements

A multiscale preconditioner for stochastic mortar mixed finite elements A multiscale preconditioner for stochastic mortar mixed finite elements Mary F. Wheeler b, Tim Wildey b, and Ivan Yotov a a Department of Mathematics, University of Pittsburgh, Pittsburgh, PA 15260 b The

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

ENHANCED CELL-CENTERED FINITE DIFFERENCES FOR ELLIPTIC EQUATIONS ON GENERAL GEOMETRY

ENHANCED CELL-CENTERED FINITE DIFFERENCES FOR ELLIPTIC EQUATIONS ON GENERAL GEOMETRY SIAM J. SCI. COMPUT. c 1998 Society for Industrial and Applied Mathematics Vol. 19, No. 2, pp. 404 425, March 1998 005 ENHANCED CELL-CENTERED FINITE DIFFERENCES FOR ELLIPTIC EQUATIONS ON GENERAL GEOMETRY

More information

Mixed Multiscale Methods for Heterogeneous Elliptic Problems

Mixed Multiscale Methods for Heterogeneous Elliptic Problems Mixed Multiscale Methods for Heterogeneous Elliptic Problems Todd Arbogast Abstract We consider a second order elliptic problem written in mixed form, i.e., as a system of two first order equations. Such

More information

Local Mesh Refinement with the PCD Method

Local Mesh Refinement with the PCD Method Advances in Dynamical Systems and Applications ISSN 0973-5321, Volume 8, Number 1, pp. 125 136 (2013) http://campus.mst.edu/adsa Local Mesh Refinement with the PCD Method Ahmed Tahiri Université Med Premier

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 Bibliography of Publications of Lawrence Charles Cowsar

A Bibliography of Publications of Lawrence Charles Cowsar A Bibliography of Publications of Lawrence Charles Cowsar Lawrence Charles Cowsar AT&T Bell Laboratories 600 Mountain Ave., 2C-302A Murray Hill, NJ 07974-0636 USA Tel: +1 908 582 5468 FAX: +1 908 582 5857

More information

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations Moshe Israeli Computer Science Department, Technion-Israel Institute of Technology, Technion city, Haifa 32000, ISRAEL Alexander

More information

A gradient recovery method based on an oblique projection and boundary modification

A gradient recovery method based on an oblique projection and boundary modification ANZIAM J. 58 (CTAC2016) pp.c34 C45, 2017 C34 A gradient recovery method based on an oblique projection and boundary modification M. Ilyas 1 B. P. Lamichhane 2 M. H. Meylan 3 (Received 24 January 2017;

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

PARTITION OF UNITY FOR THE STOKES PROBLEM ON NONMATCHING GRIDS

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

More information

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 II Todd Arbogast Department of Mathematics and Center for Subsurface Modeling, Institute for Computational Engineering and

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

A SIMPLE TUTORIAL ON DISCONTINUOUS GALERKIN METHODS. Jennifer Proft CERMICS, ENPC. J. Proft CERMICS, ENPC

A SIMPLE TUTORIAL ON DISCONTINUOUS GALERKIN METHODS. Jennifer Proft CERMICS, ENPC. J. Proft CERMICS, ENPC A SIMPLE TUTORIAL ON DISCONTINUOUS GALERKIN METHODS Jennifer Proft Outline Definitions A simple example Issues Historical development elliptic equations hyperbolic equations Discontinuous vs. continuous

More information

Advection Diffusion Problems with Pure Advection Approximation in Subregions

Advection Diffusion Problems with Pure Advection Approximation in Subregions Advection Diffusion Problems with Pure Advection Approximation in Subregions M. J. Gander, L. Halpern 2, C. Japhet 2, and V. Martin 3 Université de Genève, 2-4 rue du Lièvre, CP 64, CH-2 Genève. Switzerland.

More information

INTERGRID OPERATORS FOR THE CELL CENTERED FINITE DIFFERENCE MULTIGRID ALGORITHM ON RECTANGULAR GRIDS. 1. Introduction

INTERGRID OPERATORS FOR THE CELL CENTERED FINITE DIFFERENCE MULTIGRID ALGORITHM ON RECTANGULAR GRIDS. 1. Introduction Trends in Mathematics Information Center for Mathematical Sciences Volume 9 Number 2 December 2006 Pages 0 INTERGRID OPERATORS FOR THE CELL CENTERED FINITE DIFFERENCE MULTIGRID ALGORITHM ON RECTANGULAR

More information

Local flux mimetic finite difference methods

Local flux mimetic finite difference methods Local flux mimetic finite difference methods Konstantin Lipnikov Mikhail Shashkov Ivan Yotov November 4, 2005 Abstract We develop a local flux mimetic finite difference method for second order elliptic

More information

A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS

A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS Proceedings of ALGORITMY 2005 pp. 222 229 A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS ELENA BRAVERMAN, MOSHE ISRAELI, AND ALEXANDER SHERMAN Abstract. Based on a fast subtractional

More information

ON THE MULTIPOINT MIXED FINITE VOLUME METHODS ON QUADRILATERAL GRIDS

ON THE MULTIPOINT MIXED FINITE VOLUME METHODS ON QUADRILATERAL GRIDS ON THE MULTIPOINT MIXED FINITE VOLUME METHODS ON QUADRILATERAL GRIDS VINCENT FONTAINE 1,2 AND ANIS YOUNES 2 1 Laboratoire de Physique des Bâtiments et des Systèmes, Université de La Réunion, 15 avenue

More information

Construction of a New Domain Decomposition Method for the Stokes Equations

Construction of a New Domain Decomposition Method for the Stokes Equations Construction of a New Domain Decomposition Method for the Stokes Equations Frédéric Nataf 1 and Gerd Rapin 2 1 CMAP, CNRS; UMR7641, Ecole Polytechnique, 91128 Palaiseau Cedex, France 2 Math. Dep., NAM,

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

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS JASON ALBRIGHT, YEKATERINA EPSHTEYN, AND QING XIA Abstract. Highly-accurate numerical methods that can efficiently

More information

A Multiscale Mortar Multipoint Flux Mixed Finite Element Method

A Multiscale Mortar Multipoint Flux Mixed Finite Element Method A Multiscale Mortar Multipoint Flux Mixed Finite Element Method Mary F. Wheeler Guangri Xue Ivan Yotov Abstract In this paper, we develop a multiscale mortar multipoint flux mixed finite element method

More information

Operator Upscaling for the Wave Equation

Operator Upscaling for the Wave Equation Operator Upscaling for the Wave Equation Tetyana Vdovina Susan E. Minkoff UMBC), Oksana Korostyshevskaya Department of Computational and Applied Mathematics Rice University, Houston TX vdovina@caam.rice.edu

More information

Applications of Partial Differential Equations in Reservoir Simulation

Applications of Partial Differential Equations in Reservoir Simulation P-32 Applications of Partial Differential Equations in Reservoir Simulation Deepak Singh Summary The solution to stochastic partial differential equations may be viewed in several manners. One can view

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

A LINEAR DEGENERATE ELLIPTIC EQUATION ARISING FROM TWO-PHASE MIXTURES

A LINEAR DEGENERATE ELLIPTIC EQUATION ARISING FROM TWO-PHASE MIXTURES A LINAR DGNRAT LLIPTIC QUATION ARISING FROM TWO-PHAS MIXTURS TODD ARBOGAST AND ABRAHAM L. TAICHR Abstract. We consider the linear degenerate elliptic system of two first order equations u = aφ) p and bφ)u)

More information

ICES REPORT A Generalized Mimetic Finite Difference Method and Two-Point Flux Schemes over Voronoi Diagrams

ICES REPORT A Generalized Mimetic Finite Difference Method and Two-Point Flux Schemes over Voronoi Diagrams ICS RPORT 15-17 July 2015 A Generalized Mimetic Finite Difference Method and Two-Point Flux Schemes over Voronoi Diagrams by Omar Al-Hinai, Mary F. Wheeler, Ivan Yotov The Institute for Computational ngineering

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

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

A LAGRANGE MULTIPLIER METHOD FOR ELLIPTIC INTERFACE PROBLEMS USING NON-MATCHING MESHES

A LAGRANGE MULTIPLIER METHOD FOR ELLIPTIC INTERFACE PROBLEMS USING NON-MATCHING MESHES A LAGRANGE MULTIPLIER METHOD FOR ELLIPTIC INTERFACE PROBLEMS USING NON-MATCHING MESHES P. HANSBO Department of Applied Mechanics, Chalmers University of Technology, S-4 96 Göteborg, Sweden E-mail: hansbo@solid.chalmers.se

More information

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS

HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS HIGH-ORDER ACCURATE METHODS BASED ON DIFFERENCE POTENTIALS FOR 2D PARABOLIC INTERFACE MODELS JASON ALBRIGHT, YEKATERINA EPSHTEYN, AND QING XIA Abstract. Highly-accurate numerical methods that can efficiently

More information

From the Boundary Element Domain Decomposition Methods to Local Trefftz Finite Element Methods on Polyhedral Meshes

From the Boundary Element Domain Decomposition Methods to Local Trefftz Finite Element Methods on Polyhedral Meshes From the Boundary Element Domain Decomposition Methods to Local Trefftz Finite Element Methods on Polyhedral Meshes Dylan Copeland 1, Ulrich Langer 2, and David Pusch 3 1 Institute of Computational Mathematics,

More information

Schur Complement Technique for Advection-Diffusion Equation using Matching Structured Finite Volumes

Schur Complement Technique for Advection-Diffusion Equation using Matching Structured Finite Volumes Advances in Dynamical Systems and Applications ISSN 973-5321, Volume 8, Number 1, pp. 51 62 (213) http://campus.mst.edu/adsa Schur Complement Technique for Advection-Diffusion Equation using Matching Structured

More information

T. Arbogast, Zhen Tao, and Hailong Xiao, Multiscale mortar mixed methods for heterogeneous elliptic problems, in Recent Advances in Scientific

T. Arbogast, Zhen Tao, and Hailong Xiao, Multiscale mortar mixed methods for heterogeneous elliptic problems, in Recent Advances in Scientific T. Arbogast, Zhen Tao, and Hailong Xiao, Multiscale mortar mixed methods for heterogeneous elliptic problems, in Recent Advances in Scientific Computing and Applications, Jichun Li, Hongtao Yang, and Eric

More information

Adaptive Time Space Discretization for Combustion Problems

Adaptive Time Space Discretization for Combustion Problems Konrad-Zuse-Zentrum fu r Informationstechnik Berlin Takustraße 7 D-14195 Berlin-Dahlem Germany JENS LANG 1,BODO ERDMANN,RAINER ROITZSCH Adaptive Time Space Discretization for Combustion Problems 1 Talk

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

On Pressure Stabilization Method and Projection Method for Unsteady Navier-Stokes Equations 1

On Pressure Stabilization Method and Projection Method for Unsteady Navier-Stokes Equations 1 On Pressure Stabilization Method and Projection Method for Unsteady Navier-Stokes Equations 1 Jie Shen Department of Mathematics, Penn State University University Park, PA 1682 Abstract. We present some

More information

The Deflation Accelerated Schwarz Method for CFD

The Deflation Accelerated Schwarz Method for CFD The Deflation Accelerated Schwarz Method for CFD J. Verkaik 1, C. Vuik 2,, B.D. Paarhuis 1, and A. Twerda 1 1 TNO Science and Industry, Stieltjesweg 1, P.O. Box 155, 2600 AD Delft, The Netherlands 2 Delft

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

A Domain Decomposition Method for Quasilinear Elliptic PDEs Using Mortar Finite Elements

A Domain Decomposition Method for Quasilinear Elliptic PDEs Using Mortar Finite Elements 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 A Domain Decomposition Method for Quasilinear Elliptic PDEs Using Mortar Finite Elements Matthias Gsell and Olaf Steinbach Institute of Computational Mathematics

More information

Stochastic collocation and mixed finite elements for flow in porous media

Stochastic collocation and mixed finite elements for flow in porous media Stochastic collocation and mixed finite elements for flow in porous media Benjamin Ganis a, Hector Klie b, Mary F. Wheeler b, Tim Wildey b, Ivan Yotov a, and Dongxiao Zhang c a Department of Mathematics,

More information

A FINITE DIFFERENCE DOMAIN DECOMPOSITION ALGORITHM FOR NUMERICAL SOLUTION OF THE HEAT EQUATION

A FINITE DIFFERENCE DOMAIN DECOMPOSITION ALGORITHM FOR NUMERICAL SOLUTION OF THE HEAT EQUATION mathematics of computation volume 57, number 195 july 1991, pages 63-71 A FINITE DIFFERENCE DOMAIN DECOMPOSITION ALGORITHM FOR NUMERICAL SOLUTION OF THE HEAT EQUATION CLINT N. DAWSON, QIANG DU, AND TODD

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

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

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

TWO-SCALE SIMULATION OF MAXWELL S EQUATIONS

TWO-SCALE SIMULATION OF MAXWELL S EQUATIONS ESAIM: PROCEEDINGS, February 27, Vol.6, 2-223 Eric Cancès & Jean-Frédéric Gerbeau, Editors DOI:.5/proc:27 TWO-SCALE SIMULATION OF MAWELL S EQUATIONS Hyam Abboud,Sébastien Jund 2,Stéphanie Salmon 2, Eric

More information

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

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

More information

A MATRIX ANALYSIS OF OPERATOR-BASED UPSCALING FOR THE WAVE EQUATION

A MATRIX ANALYSIS OF OPERATOR-BASED UPSCALING FOR THE WAVE EQUATION SIAM J. NUMER. ANAL. Vol. 44, No. 2, pp. 586 62 c 2006 Society for Industrial and Applied Mathematics A MATRIX ANALYSIS OF OPERATOR-BASED UPSCALING FOR THE WAVE EQUATION OKSANA KOROSTYSHEVSKAYA AND SUSAN

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

New constructions of domain decomposition methods for systems of PDEs

New constructions of domain decomposition methods for systems of PDEs New constructions of domain decomposition methods for systems of PDEs Nouvelles constructions de méthodes de décomposition de domaine pour des systèmes d équations aux dérivées partielles V. Dolean?? F.

More information

Convergence Order Studies for Elliptic Test Problems with COMSOL Multiphysics

Convergence Order Studies for Elliptic Test Problems with COMSOL Multiphysics Convergence Order Studies for Elliptic Test Problems with COMSOL Multiphysics Shiming Yang and Matthias K. Gobbert Abstract. The convergence order of finite elements is related to the polynomial order

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

Finite Difference Methods for Boundary Value Problems

Finite Difference Methods for Boundary Value Problems Finite Difference Methods for Boundary Value Problems October 2, 2013 () Finite Differences October 2, 2013 1 / 52 Goals Learn steps to approximate BVPs using the Finite Difference Method Start with two-point

More information

From the Boundary Element DDM to local Trefftz Finite Element Methods on Polyhedral Meshes

From the Boundary Element DDM to local Trefftz Finite Element Methods on Polyhedral Meshes www.oeaw.ac.at From the Boundary Element DDM to local Trefftz Finite Element Methods on Polyhedral Meshes D. Copeland, U. Langer, D. Pusch RICAM-Report 2008-10 www.ricam.oeaw.ac.at From the Boundary Element

More information

Parallel Galerkin Domain Decomposition Procedures for Parabolic Equation on General Domain

Parallel Galerkin Domain Decomposition Procedures for Parabolic Equation on General Domain Parallel Galerkin Domain Decomposition Procedures for Parabolic Equation on General Domain Keying Ma, 1 Tongjun Sun, 1 Danping Yang 1 School of Mathematics, Shandong University, Jinan 50100, People s Republic

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

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

Generating Equidistributed Meshes in 2D via Domain Decomposition

Generating Equidistributed Meshes in 2D via Domain Decomposition Generating Equidistributed Meshes in 2D via Domain Decomposition Ronald D. Haynes and Alexander J. M. Howse 2 Introduction There are many occasions when the use of a uniform spatial grid would be prohibitively

More information

ADAPTIVE MIXED HYBRID AND MACRO HYBRID FINITE ELEMENT METHODS. 1. Introduction

ADAPTIVE MIXED HYBRID AND MACRO HYBRID FINITE ELEMENT METHODS. 1. Introduction Acta Math. Univ. Comenianae Vol. LXVII, 1(1998), pp. 159 179 159 ADAPTIVE MIXED HYBRID AND MACRO HYBRID FINITE ELEMENT METHODS R. H. W. HOPPE and B. I. WOHLMUTH Abstract. In this paper, we consider efficient

More information

Aspects of Multigrid

Aspects of Multigrid Aspects of Multigrid Kees Oosterlee 1,2 1 Delft University of Technology, Delft. 2 CWI, Center for Mathematics and Computer Science, Amsterdam, SIAM Chapter Workshop Day, May 30th 2018 C.W.Oosterlee (CWI)

More information

A multipoint flux mixed finite element method on hexahedra

A multipoint flux mixed finite element method on hexahedra A multipoint flux mixed finite element method on hexahedra Ross Ingram Mary F. Wheeler Ivan Yotov Abstract We develop a mixed finite element method for elliptic problems on hexahedral grids that reduces

More information

2 M. F. WHEELER, J. A. WHEELER, M. PESZYNSKA logging, continuous data telemetry, pressure transient testing, geostatistics, chemical tracers, and auto

2 M. F. WHEELER, J. A. WHEELER, M. PESZYNSKA logging, continuous data telemetry, pressure transient testing, geostatistics, chemical tracers, and auto A DISTRIBUTED COMPUTING PORTAL FOR COUPLING MULTI PHYSICS AND MULTIPLE DOMAINS IN POROUS MEDIA MARY F. WHEELER, JOHN A. WHEELER, & MAψLGORZATA PESZYŃSKA Abstract. We describe a computing framework or portal

More information

Space-time XFEM for two-phase mass transport

Space-time XFEM for two-phase mass transport Space-time XFEM for two-phase mass transport Space-time XFEM for two-phase mass transport Christoph Lehrenfeld joint work with Arnold Reusken EFEF, Prague, June 5-6th 2015 Christoph Lehrenfeld EFEF, Prague,

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

Iterative Methods for Stokes/Darcy Coupling

Iterative Methods for Stokes/Darcy Coupling Iterative Methods or Stokes/Darcy Coupling Marco Discacciati Ecole Polytechnique Fédérale de Lausanne Institut d Analyse et Calcul Scientiique Chair o Modelling and Scientiic Computing marco.discacciati@epl.ch

More information

2 integration methods estimate and control the temporal error through adapting both the temporal step size and the order of the temporal approximation

2 integration methods estimate and control the temporal error through adapting both the temporal step size and the order of the temporal approximation 1 Higher order, locally conservative temporal integration methods for modeling multiphase flow in porous media C.T. Miller aλ, M.W. Farthing ay, C.E. Kees a z, and C.T. Kelley bx a Center for the Advanced

More information

The Pole Condition: A Padé Approximation of the Dirichlet to Neumann Operator

The Pole Condition: A Padé Approximation of the Dirichlet to Neumann Operator The Pole Condition: A Padé Approximation of the Dirichlet to Neumann Operator Martin J. Gander and Achim Schädle Mathematics Section, University of Geneva, CH-, Geneva, Switzerland, Martin.gander@unige.ch

More information

This article appeared in a journal published by Elsevier. The attached copy is furnished to the author for internal non-commercial research and

This article appeared in a journal published by Elsevier. The attached copy is furnished to the author for internal non-commercial research and This article appeared in a ournal published by Elsevier. The attached copy is furnished to the author for internal non-commercial research and education use, including for instruction at the authors institution

More information

(1:1) 1. The gauge formulation of the Navier-Stokes equation We start with the incompressible Navier-Stokes equation 8 >< >: u t +(u r)u + rp = 1 Re 4

(1:1) 1. The gauge formulation of the Navier-Stokes equation We start with the incompressible Navier-Stokes equation 8 >< >: u t +(u r)u + rp = 1 Re 4 Gauge Finite Element Method for Incompressible Flows Weinan E 1 Courant Institute of Mathematical Sciences New York, NY 10012 Jian-Guo Liu 2 Temple University Philadelphia, PA 19122 Abstract: We present

More information

On Nonlinear Dirichlet Neumann Algorithms for Jumping Nonlinearities

On Nonlinear Dirichlet Neumann Algorithms for Jumping Nonlinearities On Nonlinear Dirichlet Neumann Algorithms for Jumping Nonlinearities Heiko Berninger, Ralf Kornhuber, and Oliver Sander FU Berlin, FB Mathematik und Informatik (http://www.math.fu-berlin.de/rd/we-02/numerik/)

More information

Ultraconvergence of ZZ Patch Recovery at Mesh Symmetry Points

Ultraconvergence of ZZ Patch Recovery at Mesh Symmetry Points Ultraconvergence of ZZ Patch Recovery at Mesh Symmetry Points Zhimin Zhang and Runchang Lin Department of Mathematics, Wayne State University Abstract. The ultraconvergence property of the Zienkiewicz-Zhu

More information

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

DELFT UNIVERSITY OF TECHNOLOGY

DELFT UNIVERSITY OF TECHNOLOGY DELFT UNIVERSITY OF TECHNOLOGY REPORT 01-13 The influence of deflation vectors at interfaces on the deflated conjugate gradient method F.J. Vermolen and C. Vuik ISSN 1389-6520 Reports of the Department

More information

Introduction into Implementation of Optimization problems with PDEs: Sheet 3

Introduction into Implementation of Optimization problems with PDEs: Sheet 3 Technische Universität München Center for Mathematical Sciences, M17 Lucas Bonifacius, Korbinian Singhammer www-m17.ma.tum.de/lehrstuhl/lehresose16labcourseoptpde Summer 216 Introduction into Implementation

More information

On the Solution of the Elliptic Interface Problems by Difference Potentials Method

On the Solution of the Elliptic Interface Problems by Difference Potentials Method On the Solution of the Elliptic Interface Problems by Difference Potentials Method Yekaterina Epshteyn and Michael Medvinsky Abstract Designing numerical methods with high-order accuracy for problems in

More information

A FETI-DP Method for Mortar Finite Element Discretization of a Fourth Order Problem

A FETI-DP Method for Mortar Finite Element Discretization of a Fourth Order Problem A FETI-DP Method for Mortar Finite Element Discretization of a Fourth Order Problem Leszek Marcinkowski 1 and Nina Dokeva 2 1 Department of Mathematics, Warsaw University, Banacha 2, 02 097 Warszawa, Poland,

More information

Numerical Solution of Integral Equations in Solidification and Melting with Spherical Symmetry

Numerical Solution of Integral Equations in Solidification and Melting with Spherical Symmetry Numerical Solution of Integral Equations in Solidification and Melting with Spherical Symmetry V. S. Ajaev and J. Tausch 2 Southern Methodist University ajaev@smu.edu 2 Southern Methodist University tausch@smu.edu

More information

Finite volume method for nonlinear transmission problems

Finite volume method for nonlinear transmission problems Finite volume method for nonlinear transmission problems Franck Boyer, Florence Hubert To cite this version: Franck Boyer, Florence Hubert. Finite volume method for nonlinear transmission problems. Proceedings

More information

A NUMERICAL APPROXIMATION OF NONFICKIAN FLOWS WITH MIXING LENGTH GROWTH IN POROUS MEDIA. 1. Introduction

A NUMERICAL APPROXIMATION OF NONFICKIAN FLOWS WITH MIXING LENGTH GROWTH IN POROUS MEDIA. 1. Introduction Acta Math. Univ. Comenianae Vol. LXX, 1(21, pp. 75 84 Proceedings of Algoritmy 2 75 A NUMERICAL APPROXIMATION OF NONFICIAN FLOWS WITH MIXING LENGTH GROWTH IN POROUS MEDIA R. E. EWING, Y. LIN and J. WANG

More information

Mortar upscaling for multiphase flow in porous media

Mortar upscaling for multiphase flow in porous media Computational Geosciences 6: 73 100, 2002. 2002 Kluwer Academic Publishers. Printed in the Netherlands. Mortar upscaling for multiphase flow in porous media Małgorzata Peszyńska a, Mary F. Wheeler a andivanyotov

More information

Convergence Behavior of a Two-Level Optimized Schwarz Preconditioner

Convergence Behavior of a Two-Level Optimized Schwarz Preconditioner Convergence Behavior of a Two-Level Optimized Schwarz Preconditioner Olivier Dubois 1 and Martin J. Gander 2 1 IMA, University of Minnesota, 207 Church St. SE, Minneapolis, MN 55455 dubois@ima.umn.edu

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 Finite Element Method Using Singular Functions for Poisson Equations: Mixed Boundary Conditions

A Finite Element Method Using Singular Functions for Poisson Equations: Mixed Boundary Conditions A Finite Element Method Using Singular Functions for Poisson Equations: Mixed Boundary Conditions Zhiqiang Cai Seokchan Kim Sangdong Kim Sooryun Kong Abstract In [7], we proposed a new finite element method

More information

ICES REPORT August T. Arbogast, D. Estep, B. Sheehan, and S. Tavener

ICES REPORT August T. Arbogast, D. Estep, B. Sheehan, and S. Tavener ICES REPORT 3-9 August 3 A-posteriori error estimates for mixed finite element and finite volume methods for problems coupled through a boundary with non-matching grids by T. Arbogast, D. Estep, B. Sheehan,

More information

Splitting methods with boundary corrections

Splitting methods with boundary corrections Splitting methods with boundary corrections Alexander Ostermann University of Innsbruck, Austria Joint work with Lukas Einkemmer Verona, April/May 2017 Strang s paper, SIAM J. Numer. Anal., 1968 S (5)

More information

Hamburger Beiträge zur Angewandten Mathematik

Hamburger Beiträge zur Angewandten Mathematik Hamburger Beiträge zur Angewandten Mathematik Numerical analysis of a control and state constrained elliptic control problem with piecewise constant control approximations Klaus Deckelnick and Michael

More information

Superconvergence and H(div) Projection for Discontinuous Galerkin Methods

Superconvergence and H(div) Projection for Discontinuous Galerkin Methods INTRNATIONAL JOURNAL FOR NUMRICAL MTHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2000; 00:1 6 [Version: 2000/07/27 v1.0] Superconvergence and H(div) Projection for Discontinuous Galerkin Methods Peter Bastian

More information

Electromagnetic Forces on Parallel Current-

Electromagnetic Forces on Parallel Current- Page 1 of 5 Tutorial Models : Electromagnetic Forces on Parallel Current-Carrying Wires Electromagnetic Forces on Parallel Current- Carrying Wires Introduction One ampere is defined as the constant current

More information