A mixed finite element method for deformed cubic meshes

Size: px
Start display at page:

Download "A mixed finite element method for deformed cubic meshes"

Transcription

1 A mixed finite element method for deformed cubic meshes Inria Project Lab technical meeting at ANDRA, hâtenay-malabry Nabil Birgle POMDAPI project-team Inria Paris-Rocquencourt, UPM With : Martin Vohralík and Jérôme Jaffré April 24, 2013 Nabil Birgle ( Inria - UPM ) 2S@Exa, ANDRA April 24, / 16

2 Goals Numerical method Define a mixed finite element method for deformed cubes 1 pressure per cell 1 flux per face High performance computing Implementation in Traces (ANDRA) Parallelism and optimization Deformed cube Nabil Birgle ( Inria - UPM ) 2S@Exa, ANDRA April 24, / 16

3 Mixed finite element methods Works well with tetrahedral and cubic meshes (Raviart-Thomas, Nédélec) Tetrahedron ube omposite element for hexahedron (Sboui-Jaffré-Roberts) Hexahedron Hexahedron split into 5 tetrahedrons Nabil Birgle ( Inria - UPM ) 2S@Exa, ANDRA April 24, / 16

4 Approximation of a deformed cube Approximation of a deformed cube { Face divided into 4 triangles ell divided into 24 tetrahedrons Deformed cube approximation The alternatives : 1. Build a composite element 2. Use the static condensation In two dimensions { Face divided into 2 segments ell divided into 8 triangles Deformed square approximation Nabil Birgle ( Inria - UPM ) 2S@Exa, ANDRA April 24, / 16

5 Mixed finite element formulation Incompressible Darcy flow u = K p in Ω u = g in Ω p = f on Ω Find u H(div; Ω) and p L 2 (Ω) such that (K 1 u, v) (p, v) = (f, v) ( u, φ) = (g, φ) v H(div; Ω) φ L 2 (Ω) Find u h RTN 0 (Ω h ) and p h L 2 (Ω h ) such that (K 1 u h, v h ) (p h, v h ) = (f, v h ) ( u h, φ h ) = (g, φ h ) v h RTN 0 (Ω h ) φ h L 2 (Ω h ) Nabil Birgle ( Inria - UPM ) 2S@Exa, ANDRA April 24, / 16

6 Static condensation in two steps Standard mixed finite element on T h gives ( A B t B 0 ) ( ) U P = ( ) F G The mesh h and the triangular sub-mesh T h Reduction of the dimension of the system in two steps : 1. Eliminate internal d.o.f.s 1 pressure per cell h 2 fluxes per face 2. Reduction to 1 flux per face 1 pressure per cell h 1 flux per face Nabil Birgle ( Inria - UPM ) 2S@Exa, ANDRA April 24, / 16

7 The global system in terms of local matrices The linear system ( ) ( ) A B t U = B 0 P ( ) F G ell divided into 8 triangles T γ s and θ s are local to global matrix extensions. A = γ T (A T ) = γ (A ) A = γ T (A T ) T T h h B = T T h γ T (B T ) = γ (B ) B = γ T (B T ) T T h h F = T T h θ T (F T ) = θ (F ) F = θ T (F T ) T T h h G = T T h θ T (G T ) = θ (G ) G = θ T (G T ) T T h h T T h Nabil Birgle ( Inria - UPM ) 2S@Exa, ANDRA April 24, / 16

8 Eliminate internal d.o.f.s for a cell h Internal flux U int External flux U ext Pressure variation P 0 Pressure mean P 1 Local equations on the cell The cell A int,int U int +A int,ext U ext + (B 0,int ) t P 0 =F int (1) B 0,int U int + B 0,ext U ext =G 0 (2) A ext,int U int +A ext,ext U ext + (B 0,ext ) t P 0 + (B 1,ext ) t P 1 =F ext (3) B 1,ext U ext =G 1 (4) Eliminate U int, P0 from eqs (1),(2) to obtain local eqs for Uext, P1. Thus one obtains the global intermediary system (Ā t) (Ū P) ( B FḠ) Ū : 2 fluxes per face of = B 0 P : 1 pressure per cell Nabil Birgle ( Inria - UPM ) 2S@Exa, ANDRA April 24, / 16

9 Static condensation : second step We start from the intermediary system (Ā t) (Ū P) ( B FḠ) Ū : 2 fluxes per face of = h B 0 P : 1 pressure per cell h How to reduce the system to only 1 pressure per cell h and 1 flux per face? The mesh h It is not possible when considering a single cell. We need to consider patches P of 4 cells : A patch P Nabil Birgle ( Inria - UPM ) 2S@Exa, ANDRA April 24, / 16

10 Reduction to 1 flux per face On the patch P define red subface s flux Ūr P blue subface s flux Ūb P For each face e with subfaces define A patch P U + e = n e,b Ū b e + n e,r Ū r e In matrix form U + = NŪ Under some constraint on N, we will construct a linear system with unknown U + and P Nabil Birgle ( Inria - UPM ) 2S@Exa, ANDRA April 24, / 16

11 Reduction to 1 flux per face On the patch P : Rectangular system (12 24) (Ār P B r P Ā b P B b P ) (Ūr ) P = Ū b P ( Fint P Ḡ P ( B P ) t ) PP Add equations from the definition of U + A patch P Square system (24 24), nonsingular when n e,r n e,b for all faces e and (n e,r, n e,b ) (n e,r, n e,b) for at least two faces e, e in the patch : Ā r P Ā b (Ūr ) P F P ( B P ) t PP B r P B b P P N r P N b Ū b = Ḡ P P P Ū + P One can eliminate Ūr P and Ūb P in terms of P P and Ū+ P and proceed as in the first step. Nabil Birgle ( Inria - UPM ) 2S@Exa, ANDRA April 24, / 16

12 Numerical experiment Test case : 36 cells (288 triangles) Initial values K = I f = 0 g = 2(2π) 2 sin(2πx) sin(2πy) Exact solution p = sin(2πx) sin(2πy) ( ) cos(2πx) sin(2πy) u = 2π sin(2πx) cos(2πy) The mesh h and the triangular sub-mesh T h Exact pressure Nabil Birgle ( Inria - UPM ) 2S@Exa, ANDRA April 24, / 16

13 Numerical experiment Test case : 36 cells (288 triangles) Approximation of the pressure MFE method on T h Intermediary method Final method p P L 2 = p P L 2 = p P L 2 = onditioning of the matrices cond = 20 cond = 55 cond = onditioning s mean of the local matrices cond = 49 cond = Nabil Birgle ( Inria - UPM ) 2S@Exa, ANDRA April 24, / 16

14 Numerical experiment Test case : 36 cells (288 triangles) Nonzero coefficients of the matrices MFE method on T h ( ) Intermediary method ( ) Final method ( ) Stencil of the matrices s = 7 s = 16 s = 29 Nabil Birgle ( Inria - UPM ) 2S@Exa, ANDRA April 24, / 16

15 onclusion and perspective onclusion 1. We succeeded at solving the problem with 1 pressure per cell and 1 flux per face on a very coarse mesh 2. Resulting matrix is lower dimension, much denser and badly conditioned Perspective Is it possible to improve dramatically the condition number by choosing a suitable N? Nabil Birgle ( Inria - UPM ) 2S@Exa, ANDRA April 24, / 16

16 References I Amel Sboui, Jérôme Jaffré, and Jean Roberts. A composite mixed finite element for hexahedral grids. SIAM Journal on Scientific omputing, 31(4) : , Martin Vohralík and Barbara I. Wohlmuth. From face to element unknowns by local static condensation with application to nonconforming finite elements. omputer Methods in Applied Mechanics and Engineering, 253(0) : , Martin Vohralík and Barbara I. Wohlmuth. Mixed finite element methods : Implementation with one unknown per element, local flux expressions, positivity, polygonal meshes, and relations to other methods. Mathematical Models and Methods in Applied Sciences, 23(05) : , Nabil Birgle ( Inria - UPM ) 2S@Exa, ANDRA April 24, / 16

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

Multi-point flux approximation L-method in 3D: Numerical convergence and application to two-phase flow through porous media

Multi-point flux approximation L-method in 3D: Numerical convergence and application to two-phase flow through porous media XXXX, 1 41 De Gruyter YYYY Multi-point flux approximation L-method in 3D: Numerical convergence and application to two-phase flow through porous media Markus Wolff, Yufei Cao, Bernd Flemisch, Rainer Helmig

More information

ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS

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

More information

A reduced fracture model for two-phase flow with different rock types

A reduced fracture model for two-phase flow with different rock types A reduced fracture model for two-phase flow with different rock types Elyes Ahmed, Jérôme Jaffré, Jean E. Roberts To cite this version: Elyes Ahmed, Jérôme Jaffré, Jean E. Roberts. different rock types.

More information

MODEL OF GROUNDWATER FLOW IN FRACTURED ENVIRONMENT

MODEL OF GROUNDWATER FLOW IN FRACTURED ENVIRONMENT Proceedings of ALGORITMY 2002 Conference on Scientific Computing, pp. 138 145 MODEL OF GROUNDWATER FLOW IN FRACTURED ENVIRONMENT JIŘÍ MARYŠKA, OTTO SEVERÝN AND MARTIN VOHRALÍK Abstract. A stochastic discrete

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

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

A super convergent hybridisable discontinuous Galerkin method for linear elasticity

A super convergent hybridisable discontinuous Galerkin method for linear elasticity A super convergent hybridisable discontinuous Galerkin method for linear elasticity arxiv:82.223v [math.na] 6 Feb 28 Ruben Sevilla Zienkiewicz Centre for Computational Engineering, College of Engineering,

More information

A POSTERIORI ERROR ESTIMATES INCLUDING ALGEBRAIC ERROR: COMPUTABLE UPPER BOUNDS AND STOPPING CRITERIA FOR ITERATIVE SOLVERS

A POSTERIORI ERROR ESTIMATES INCLUDING ALGEBRAIC ERROR: COMPUTABLE UPPER BOUNDS AND STOPPING CRITERIA FOR ITERATIVE SOLVERS A POSTERIORI ERROR ESTIMATES INCLUDING ALGEBRAIC ERROR: COMPUTABLE UPPER BOUNDS AND STOPPING CRITERIA FOR ITERATIVE SOLVERS PAVEL JIRÁNEK, ZDENĚK STRAKOŠ, AND MARTIN VOHRALÍK Abstract. We consider the

More information

Weak Galerkin Finite Element Methods and Applications

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

More information

A P4 BUBBLE ENRICHED P3 DIVERGENCE-FREE FINITE ELEMENT ON TRIANGULAR GRIDS

A P4 BUBBLE ENRICHED P3 DIVERGENCE-FREE FINITE ELEMENT ON TRIANGULAR GRIDS A P4 BUBBLE ENRICHED P3 DIVERGENCE-FREE FINITE ELEMENT ON TRIANGULAR GRIDS SHANGYOU ZHANG DEDICATED TO PROFESSOR PETER MONK ON THE OCCASION OF HIS 6TH BIRTHDAY Abstract. On triangular grids, the continuous

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

Finite Volume Methods Schemes and Analysis course at the University of Wroclaw

Finite Volume Methods Schemes and Analysis course at the University of Wroclaw Finite Volume Methods Schemes and Analysis course at the University of Wroclaw Robert Eymard 1, Thierry Gallouët 2 and Raphaèle Herbin 3 April, 2008 1 Université Paris-Est Marne-la-Vallée 2 Université

More information

Domain decomposition for the Jacobi-Davidson method: practical strategies

Domain decomposition for the Jacobi-Davidson method: practical strategies Chapter 4 Domain decomposition for the Jacobi-Davidson method: practical strategies Abstract The Jacobi-Davidson method is an iterative method for the computation of solutions of large eigenvalue problems.

More information

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA Introduction to Finite and Spectral Element Methods Using MATLAB Second Edition C. Pozrikidis University of Massachusetts Amherst, USA (g) CRC Press Taylor & Francis Group Boca Raton London New York CRC

More information

Adaptive methods for control problems with finite-dimensional control space

Adaptive methods for control problems with finite-dimensional control space Adaptive methods for control problems with finite-dimensional control space Saheed Akindeinde and Daniel Wachsmuth Johann Radon Institute for Computational and Applied Mathematics (RICAM) Austrian Academy

More information

Méthodes de raffinement espace-temps

Méthodes de raffinement espace-temps Méthodes de raffinement espace-temps Caroline Japhet Université Paris 13 & University of Maryland Laurence Halpern Université Paris 13 Jérémie Szeftel Ecole Normale Supérieure, Paris Pascal Omnes CEA,

More information

A note on discontinuous Galerkin divergence-free solutions of the Navier-Stokes equations

A note on discontinuous Galerkin divergence-free solutions of the Navier-Stokes equations A note on discontinuous Galerkin divergence-free solutions of the Navier-Stokes equations Bernardo Cockburn Guido anschat Dominik Schötzau June 1, 2007 Journal of Scientific Computing, Vol. 31, 2007, pp.

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

C 0 P 2 P 0 Stokes finite element pair on sub-hexahedron tetrahedral grids

C 0 P 2 P 0 Stokes finite element pair on sub-hexahedron tetrahedral grids Calcolo 2017 54:1403 1417 https://doi.org/10.1007/s1002-017-0235-2 C 0 P 2 P 0 Stokes finite element pair on sub-hexahedron tetrahedral grids Shangyou Zhang 1 Shuo Zhang 2 Received: 22 March 2017 / Accepted:

More information

Space-Time Domain Decomposition Methods for Transport Problems in Porous Media

Space-Time Domain Decomposition Methods for Transport Problems in Porous Media 1 / 49 Space-Time Domain Decomposition Methods for Transport Problems in Porous Media Thi-Thao-Phuong Hoang, Elyes Ahmed, Jérôme Jaffré, Caroline Japhet, Michel Kern, Jean Roberts INRIA Paris-Rocquencourt

More information

Equilibrated Residual Error Estimates are p-robust

Equilibrated Residual Error Estimates are p-robust Equilibrated Residual Error Estimates are p-robust Dietrich Braess, Veronika Pillwein and Joachim Schöberl April 16, 2008 Abstract Equilibrated residual error estimators applied to high order finite elements

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

Construction of H(div)-Conforming Mixed Finite Elements on Cuboidal Hexahedra

Construction of H(div)-Conforming Mixed Finite Elements on Cuboidal Hexahedra Numerische Mathematik manuscript No. (will be inserted by the editor) Construction of H(div)-Conforming Mixed Finite Elements on Cuboidal Hexahedra Todd Arbogast Zhen Tao Received: July 9, 27 / Accepted:

More information

arxiv: v2 [math.na] 23 Apr 2016

arxiv: v2 [math.na] 23 Apr 2016 Improved ZZ A Posteriori Error Estimators for Diffusion Problems: Conforming Linear Elements arxiv:508.009v2 [math.na] 23 Apr 206 Zhiqiang Cai Cuiyu He Shun Zhang May 2, 208 Abstract. In [8], we introduced

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

Optimal Interface Conditions for an Arbitrary Decomposition into Subdomains

Optimal Interface Conditions for an Arbitrary Decomposition into Subdomains Optimal Interface Conditions for an Arbitrary Decomposition into Subdomains Martin J. Gander and Felix Kwok Section de mathématiques, Université de Genève, Geneva CH-1211, Switzerland, Martin.Gander@unige.ch;

More information

A mixed finite volume scheme for anisotropic diffusion problems on any grid

A mixed finite volume scheme for anisotropic diffusion problems on any grid A mixed finite volume scheme for anisotropic diffusion problems on any grid Jérôme Droniou 1 and Robert Eymard 2 08/08/2006 Abstract We present a new finite volume scheme for anisotropic heterogeneous

More information

HEXAHEDRAL H(DIV) AND H(CURL) FINITE ELEMENTS

HEXAHEDRAL H(DIV) AND H(CURL) FINITE ELEMENTS HEXAHEDRAL H(DIV) AND H(CURL) FINITE ELEMENTS RICHARD S. FAL, PAOLO GATTO, AND PETER MON Abstract. We study the approximation properties of some finite element subspaces of H(div; Ω) and H(curl ; Ω) defined

More information

Quantities which have only magnitude are called scalars. Quantities which have magnitude and direction are called vectors.

Quantities which have only magnitude are called scalars. Quantities which have magnitude and direction are called vectors. Vectors summary Quantities which have only magnitude are called scalars. Quantities which have magnitude and direction are called vectors. AB is the position vector of B relative to A and is the vector

More information

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

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

More information

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

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

An A Posteriori Error Estimate for Discontinuous Galerkin Methods

An A Posteriori Error Estimate for Discontinuous Galerkin Methods An A Posteriori Error Estimate for Discontinuous Galerkin Methods Mats G Larson mgl@math.chalmers.se Chalmers Finite Element Center Mats G Larson Chalmers Finite Element Center p.1 Outline We present an

More information

ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS

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

More information

Discontinuous Galerkin Methods

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

More information

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

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

More information

A mixed finite volume scheme for anisotropic diffusion problems on any grid

A mixed finite volume scheme for anisotropic diffusion problems on any grid A mixed finite volume scheme for anisotropic diffusion problems on any grid arxiv:math/64v [math.na] 3 Apr 26 Jérôme Droniou and Robert Eymard 2 27/3/26 Abstract We present a new finite volume scheme for

More information

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

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

More information

AN UNFITTED METHOD FOR TWO-PHASE FLOW IN FRACTURED POROUS MEDIA

AN UNFITTED METHOD FOR TWO-PHASE FLOW IN FRACTURED POROUS MEDIA XIX International Conference on Water Resources CMWR 2012 University of Illinois at Urbana-Champaign June 17-22,2012 AN UNFIED MEHOD FOR WO-PHASE FLOW IN FRACURED POROUS MEDIA A. Fumagalli and A. Scotti

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

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

Mimetic Finite Difference methods

Mimetic Finite Difference methods Mimetic Finite Difference methods An introduction Andrea Cangiani Università di Roma La Sapienza Seminario di Modellistica Differenziale Numerica 2 dicembre 2008 Andrea Cangiani (IAC CNR) mimetic finite

More information

DISCRETE HODGE HELMHOLTZ

DISCRETE HODGE HELMHOLTZ Monografías Matemáticas García de Galdeano 39, 1 10 (2014) DISCRETE HODGE HELMHOLTZ DECOMPOSITION Etienne Ahusborde, Mejdi Azaïez, Jean-Paul Caltagirone, Mark Gerritsma and Antoine Lemoine Abstract. This

More information

Guaranteed and robust a posteriori bounds for Laplace eigenvalues and eigenvectors: conforming approximations

Guaranteed and robust a posteriori bounds for Laplace eigenvalues and eigenvectors: conforming approximations Guaranteed and robust a posteriori bounds for Laplace eigenvalues and eigenvectors: conforming approximations Eric Cancès, Geneviève Dusson, Yvon Maday, Benjamin Stamm, Martin Vohralík To cite this version:

More information

A Mixed Nonconforming Finite Element for Linear Elasticity

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

More information

A posteriori error estimates for space-time domain decomposition method for two-phase flow problem

A posteriori error estimates for space-time domain decomposition method for two-phase flow problem A posteriori error estimates for space-time domain decomposition method for two-phase flow problem Sarah Ali Hassan, Elyes Ahmed, Caroline Japhet, Michel Kern, Martin Vohralík INRIA Paris & ENPC (project-team

More information

Hybrid (DG) Methods for the Helmholtz Equation

Hybrid (DG) Methods for the Helmholtz Equation Hybrid (DG) Methods for the Helmholtz Equation Joachim Schöberl Computational Mathematics in Engineering Institute for Analysis and Scientific Computing Vienna University of Technology Contributions by

More information

A mixed finite element approximation of the Stokes equations with the boundary condition of type (D+N)

A mixed finite element approximation of the Stokes equations with the boundary condition of type (D+N) wwwijmercom Vol2, Issue1, Jan-Feb 2012 pp-464-472 ISSN: 2249-6645 A mixed finite element approximation of the Stokes equations with the boundary condition of type (D+N) Jaouad El-Mekkaoui 1, Abdeslam Elakkad

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

TMA4220: Programming project - part 1

TMA4220: Programming project - part 1 TMA4220: Programming project - part 1 TMA4220 - Numerical solution of partial differential equations using the finite element method The programming project will be split into two parts. This is the first

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

Splitting methods in the design of coupled flow and mechanics simulators

Splitting methods in the design of coupled flow and mechanics simulators Splitting methods in the design of coupled flow and mechanics simulators Sílvia Barbeiro CMUC, Department of Mathematics, University of Coimbra PhD Program in Mathematics Coimbra, November 17, 2010 Sílvia

More information

On angle conditions in the finite element method. Institute of Mathematics, Academy of Sciences Prague, Czech Republic

On angle conditions in the finite element method. Institute of Mathematics, Academy of Sciences Prague, Czech Republic On angle conditions in the finite element method Michal Křížek Institute of Mathematics, Academy of Sciences Prague, Czech Republic Joint work with Jan Brandts (University of Amsterdam), Antti Hannukainen

More information

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

b i (x) u + c(x)u = f in Ω,

b i (x) u + c(x)u = f in Ω, SIAM J. NUMER. ANAL. Vol. 39, No. 6, pp. 1938 1953 c 2002 Society for Industrial and Applied Mathematics SUBOPTIMAL AND OPTIMAL CONVERGENCE IN MIXED FINITE ELEMENT METHODS ALAN DEMLOW Abstract. An elliptic

More information

STABILIZATION IN RELATION TO WAVENUMBER IN HDG METHODS

STABILIZATION IN RELATION TO WAVENUMBER IN HDG METHODS STABILIZATION IN RELATION TO WAVENUMBER IN HDG METHODS J. GOPALAKRISHNAN, S. LANTERI, N. OLIVARES, AND R. PERRUSSEL Abstract. Simulation of wave propagation through complex media relies on proper understanding

More information

The Finite Volume Mesh

The Finite Volume Mesh FMIA F Moukalled L Mangani M Darwish An Advanced Introduction with OpenFOAM and Matlab This textbook explores both the theoretical foundation of the Finite Volume Method (FVM) and its applications in Computational

More information

Discontinuous Galerkin Methods: Theory, Computation and Applications

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

More information

ANR Project DEDALES Algebraic and Geometric Domain Decomposition for Subsurface Flow

ANR Project DEDALES Algebraic and Geometric Domain Decomposition for Subsurface Flow ANR Project DEDALES Algebraic and Geometric Domain Decomposition for Subsurface Flow Michel Kern Inria Paris Rocquencourt Maison de la Simulation C2S@Exa Days, Inria Paris Centre, Novembre 2016 M. Kern

More information

Pivoting. Reading: GV96 Section 3.4, Stew98 Chapter 3: 1.3

Pivoting. Reading: GV96 Section 3.4, Stew98 Chapter 3: 1.3 Pivoting Reading: GV96 Section 3.4, Stew98 Chapter 3: 1.3 In the previous discussions we have assumed that the LU factorization of A existed and the various versions could compute it in a stable manner.

More information

Comparison of V-cycle Multigrid Method for Cell-centered Finite Difference on Triangular Meshes

Comparison of V-cycle Multigrid Method for Cell-centered Finite Difference on Triangular Meshes Comparison of V-cycle Multigrid Method for Cell-centered Finite Difference on Triangular Meshes Do Y. Kwak, 1 JunS.Lee 1 Department of Mathematics, KAIST, Taejon 305-701, Korea Department of Mathematics,

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

Jae Heon Yun and Yu Du Han

Jae Heon Yun and Yu Du Han Bull. Korean Math. Soc. 39 (2002), No. 3, pp. 495 509 MODIFIED INCOMPLETE CHOLESKY FACTORIZATION PRECONDITIONERS FOR A SYMMETRIC POSITIVE DEFINITE MATRIX Jae Heon Yun and Yu Du Han Abstract. We propose

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

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

Error analysis for a new mixed finite element method in 3D

Error analysis for a new mixed finite element method in 3D Trabalho apresentado no CNMAC, Gramado - RS, 2016. Proceeding Series of the Brazilian Society of Computational and Applied Mathematics Error analysis for a new mixed finite element method in 3D Douglas

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

REMARKS ON DISCRETIZATIONS OF CONVECTION TERMS IN HYBRID MIMETIC MIXED METHODS

REMARKS ON DISCRETIZATIONS OF CONVECTION TERMS IN HYBRID MIMETIC MIXED METHODS NETWORS AND HETEROGENEOUS MEDIA c American Institute of Mathematical Sciences Volume 5, Number 3, September 2010 doi:10.3934/nhm.2010.5.xx pp. 1 xx REMARS ON DISCRETIZATIONS OF CONVECTION TERMS IN HYBRID

More information

arxiv: v1 [math.na] 11 Sep 2017

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

More information

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

Multigrid finite element methods on semi-structured triangular grids

Multigrid finite element methods on semi-structured triangular grids XXI Congreso de Ecuaciones Diferenciales y Aplicaciones XI Congreso de Matemática Aplicada Ciudad Real, -5 septiembre 009 (pp. 8) Multigrid finite element methods on semi-structured triangular grids F.J.

More information

Mesh Grading towards Singular Points Seminar : Elliptic Problems on Non-smooth Domain

Mesh Grading towards Singular Points Seminar : Elliptic Problems on Non-smooth Domain Mesh Grading towards Singular Points Seminar : Elliptic Problems on Non-smooth Domain Stephen Edward Moore Johann Radon Institute for Computational and Applied Mathematics Austrian Academy of Sciences,

More information

Polynomial-degree-robust liftings for potentials and fluxes

Polynomial-degree-robust liftings for potentials and fluxes Polynomial-degree-robust liftings for potentials and fluxes and Martin Vohraĺık Université Paris-Est, CERMICS (ENPC) and SERENA Project-Team, INRIA, France RAFEM, Hong-Kong, March 2017 Outline 1. Motivation:

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

Approximation SEM-DG pour les problèmes d ondes elasto-acoustiques

Approximation SEM-DG pour les problèmes d ondes elasto-acoustiques Approximation SEM-DG pour les problèmes d ondes elasto-acoustiques Helene Barucq, Henri Calandra, Aurélien Citrain, Julien Diaz, Christian Gout To cite this version: Helene Barucq, Henri Calandra, Aurélien

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

Finite Volume for Fusion Simulations

Finite Volume for Fusion Simulations Finite Volume for Fusion Simulations Elise Estibals, Hervé Guillard, Afeintou Sangam To cite this version: Elise Estibals, Hervé Guillard, Afeintou Sangam. Finite Volume for Fusion Simulations. Jorek Meeting

More information

An Adaptive Mixed Finite Element Method using the Lagrange Multiplier Technique

An Adaptive Mixed Finite Element Method using the Lagrange Multiplier Technique An Adaptive Mixed Finite Element Method using the Lagrange Multiplier Technique by Michael Gagnon A Project Report Submitted to the Faculty of the WORCESTER POLYTECHNIC INSTITUTE In partial fulfillment

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

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

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

More information

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

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

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

Applied Linear Algebra in Geoscience Using MATLAB

Applied Linear Algebra in Geoscience Using MATLAB Applied Linear Algebra in Geoscience Using MATLAB Contents Getting Started Creating Arrays Mathematical Operations with Arrays Using Script Files and Managing Data Two-Dimensional Plots Programming in

More information

Numerical Integration over Pyramids

Numerical Integration over Pyramids Numerical Integration over Pyramids Chuan Miao Chen, Michal řížek, Liping Liu Corresponding Author: Dr. Liping Liu Department of Mathematical Sciences Lakehead University Thunder Bay, ON Canada P7B 5E1

More information

PREPRINT 2010:23. A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO

PREPRINT 2010:23. A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO PREPRINT 2010:23 A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO Department of Mathematical Sciences Division of Mathematics CHALMERS UNIVERSITY OF TECHNOLOGY UNIVERSITY OF GOTHENBURG

More information

A Mixed Finite Volume Method for Elliptic Problems

A Mixed Finite Volume Method for Elliptic Problems A Mixed Finite Volume Method for Elliptic Problems Ilya. Mishev and Qian-Yong Chen ExxonMobil Upstream Research Company P.O. Box 2189, Houston, TX 77252-2189 Abstract We derive a novel finite volume method

More information

Adding a new finite element to FreeFem++:

Adding a new finite element to FreeFem++: Adding a new finite element to FreeFem++: the example of edge elements Marcella Bonazzoli 1 2, Victorita Dolean 1,3, Frédéric Hecht 2, Francesca Rapetti 1, Pierre-Henri Tournier 2 1 LJAD, University of

More information

A posteriori error estimates, stopping criteria, and adaptivity for multiphase compositional Darcy flows in porous media

A posteriori error estimates, stopping criteria, and adaptivity for multiphase compositional Darcy flows in porous media A posteriori error estimates, stopping criteria, and adaptivity for multiphase compositional Darcy flows in porous media Daniele A. Di Pietro 1, Eric Flauraud, artin Vohralík 3, and Soleiman Yousef,4 1

More information

EXACT DE RHAM SEQUENCES OF SPACES DEFINED ON MACRO-ELEMENTS IN TWO AND THREE SPATIAL DIMENSIONS

EXACT DE RHAM SEQUENCES OF SPACES DEFINED ON MACRO-ELEMENTS IN TWO AND THREE SPATIAL DIMENSIONS EXACT DE RHAM SEQUENCES OF SPACES DEFINED ON MACRO-ELEMENTS IN TWO AND THREE SPATIAL DIMENSIONS JOSEPH E. PASCIAK AND PANAYOT S. VASSILEVSKI Abstract. This paper proposes new finite element spaces that

More information

Mimetic Finite Difference Methods

Mimetic Finite Difference Methods Mimetic Finite Difference Methods Applications to the Diffusion Equation Asbjørn Nilsen Riseth May 15, 2014 2014-05-15 Mimetic Finite Difference Methods Mimetic Finite Difference Methods Applications to

More information

An Accurate Quadrature for the Numerical Integration of Polynomial Functions

An Accurate Quadrature for the Numerical Integration of Polynomial Functions International Journal of Applied Mathematics and Theoretical Physics 2018; 4(1: 1-7 http://www.sciencepublishinggroup.com/j/ijamtp doi: 10.11648/j.ijamtp.20180401.11 ISSN: 2575-5919 (Print; ISSN: 2575-5927

More information

Polynomial-degree-robust a posteriori estimates in a unified setting for conforming, nonconforming, discontinuous Galerkin, and mixed discretizations

Polynomial-degree-robust a posteriori estimates in a unified setting for conforming, nonconforming, discontinuous Galerkin, and mixed discretizations Polynomial-degree-robust a posteriori estimates in a unified setting for conforming, nonconforming, discontinuous Galerkin, and mixed discretizations Alexandre Ern, Martin Vohralík To cite this version:

More information

A High-Order Discontinuous Galerkin Method for the Unsteady Incompressible Navier-Stokes Equations

A High-Order Discontinuous Galerkin Method for the Unsteady Incompressible Navier-Stokes Equations A High-Order Discontinuous Galerkin Method for the Unsteady Incompressible Navier-Stokes Equations Khosro Shahbazi 1, Paul F. Fischer 2 and C. Ross Ethier 1 1 University of Toronto and 2 Argonne National

More information

Iterative Methods for Linear Systems

Iterative Methods for Linear Systems Iterative Methods for Linear Systems 1. Introduction: Direct solvers versus iterative solvers In many applications we have to solve a linear system Ax = b with A R n n and b R n given. If n is large the

More information

A MIXED MULTISCALE FINITE ELEMENT METHOD FOR ELLIPTIC PROBLEMS WITH OSCILLATING COEFFICIENTS

A MIXED MULTISCALE FINITE ELEMENT METHOD FOR ELLIPTIC PROBLEMS WITH OSCILLATING COEFFICIENTS MATHEMATIC OF COMPUTATION Volume 72, Number 242, Pages 541 576 0025-571802)01441-2 Article electronically published on June 28, 2002 A MIXED MULTICALE FINITE ELEMENT METHOD FOR ELLIPTIC PROBLEM WITH OCILLATING

More information

Dense LU factorization and its error analysis

Dense LU factorization and its error analysis Dense LU factorization and its error analysis Laura Grigori INRIA and LJLL, UPMC February 2016 Plan Basis of floating point arithmetic and stability analysis Notation, results, proofs taken from [N.J.Higham,

More information

The matrix will only be consistent if the last entry of row three is 0, meaning 2b 3 + b 2 b 1 = 0.

The matrix will only be consistent if the last entry of row three is 0, meaning 2b 3 + b 2 b 1 = 0. ) Find all solutions of the linear system. Express the answer in vector form. x + 2x + x + x 5 = 2 2x 2 + 2x + 2x + x 5 = 8 x + 2x + x + 9x 5 = 2 2 Solution: Reduce the augmented matrix [ 2 2 2 8 ] to

More information

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis. Volume 37, pp. 166-172, 2010. Copyright 2010,. ISSN 1068-9613. ETNA A GRADIENT RECOVERY OPERATOR BASED ON AN OBLIQUE PROJECTION BISHNU P. LAMICHHANE Abstract.

More information