Papers
Topics
Authors
Recent
Gemini 2.5 Flash
Gemini 2.5 Flash
144 tokens/sec
GPT-4o
8 tokens/sec
Gemini 2.5 Pro Pro
46 tokens/sec
o3 Pro
4 tokens/sec
GPT-4.1 Pro
38 tokens/sec
DeepSeek R1 via Azure Pro
28 tokens/sec
2000 character limit reached

Raviart–Thomas Mixed Finite Element Method

Updated 2 July 2025
  • The Raviart–Thomas mixed finite element method is a discretization framework for conservation PDEs that employs H(div)-conforming vector spaces and piecewise scalar functions.
  • It directly computes both the primary variable and its flux within a coupled system, preserving local conservation and linking finite element with finite volume approaches.
  • Its Petrov–Galerkin variants use dual basis functions to create sparse matrices and achieve optimal first-order error estimates, enhancing computational efficiency.

The Raviart–Thomas mixed finite element method (RT-MFEM) provides a framework for discretizing partial differential equations (PDEs) in mixed variational form, especially those expressing conservation of flux, such as the Poisson equation, Darcy flow, and diffusion processes in porous media. The method is characterized by the use of H(div)H(\mathrm{div})-conforming vector-valued finite element spaces (Raviart–Thomas spaces) for flux variables, combined with suitable approximation spaces for scalar variables (typically piecewise constants or discontinuous polynomials). This allows the direct computation of both the primary variable (e.g., pressure or potential) and its flux within a single, strongly coupled system, preserving key structural properties such as local conservation and enabling a direct link between finite element and finite volume methodologies.

1. Variational Principles and Mixed Formulation

The RT-MFEM originates from rewriting second-order elliptic PDEs in mixed form. For the Poisson equation with Dirichlet boundary conditions,

Δu=fin Ω,u=0 on Ω,-\Delta u = f \quad \text{in } \Omega, \quad u = 0 \text{ on } \partial \Omega,

a flux variable p=up = \nabla u is introduced, producing the first-order system: {p=u, divp+f=0.\begin{cases} p = \nabla u, \ \operatorname{div} p + f = 0. \end{cases} The corresponding mixed variational formulation seeks (p,u)(p, u) such that

(p,q)+(u,divq)=0qH(div,Ω), (divp,v)=(f,v)vL2(Ω).(p, q) + (u, \operatorname{div} q) = 0 \qquad \forall q \in H(\operatorname{div}, \Omega), \ -(\operatorname{div} p, v) = (f, v) \qquad \forall v \in L^2(\Omega).

Here, H(div,Ω)H(\operatorname{div}, \Omega) is the space of square-integrable vector fields with square-integrable divergence. This framework sets the stage for discretization with the RT spaces and their finite-dimensional analogues.

2. Raviart–Thomas Finite Element Spaces and Discretization

The lowest-order Raviart–Thomas space on a triangle KK is given by

RT0(K)={qq(x)=aK+bKx,  aKR2,  bKR},RT_0(K) = \left\{ \mathbf{q} \mid \mathbf{q}(x) = a_K + b_K x, \; a_K \in \mathbb{R}^2, \; b_K \in \mathbb{R} \right\},

with degrees of freedom corresponding to the normal components of q\mathbf{q} over each edge of the element. Globally, the discrete flux space is assembled to ensure H(div)H(\mathrm{div}) conformity across elements.

The standard RT mixed finite element method discretizes the problem as: Find (uT,pT)L2(Ω)T×HT(div,Ω) such that\text{Find } (u_{\mathcal{T}}, p_{\mathcal{T}}) \in L^2(\Omega)_T \times H_T(\operatorname{div}, \Omega) \text{ such that}

(pT,q)+(uT,divq)=0,qHT(div,Ω), (divpT,v)+(f,v)=0,vL2(Ω)T,\begin{aligned} (p_{\mathcal{T}}, q) + (u_{\mathcal{T}}, \operatorname{div} q) &= 0, \quad \forall q \in H_T(\operatorname{div},\Omega), \ (\operatorname{div} p_{\mathcal{T}}, v) + (f, v) &= 0, \quad \forall v \in L^2(\Omega)_T, \end{aligned}

where L2(Ω)TL^2(\Omega)_T is the space of piecewise constants, and HT(div,Ω)H_T(\operatorname{div}, \Omega) is spanned by RT basis functions indexed by mesh edges.

A haLLMark of the RT discretization is exact local conservation: for every element KK,

KdivpTdx+Kfdx=0,\int_K \operatorname{div} p_{\mathcal{T}} \, dx + \int_K f\, dx = 0,

directly reflecting the PDE’s conservation law at the discrete level.

3. Petrov-Galerkin Variants and Dual Raviart–Thomas Bases

In classical RT methods, the test and trial spaces for the flux variable coincide (i.e., a Galerkin approach). Petrov-Galerkin variants employ a different test space, producing notable computational and structural benefits. This is accomplished by constructing a dual RT basis {φa}\{ \varphi_a^* \}, defined by

(φa,φb)=δab,(\varphi_a, \varphi_b^*) = \delta_{ab},

where a,ba,b are edge indices and (,)(\cdot,\cdot) is the L2L^2 inner product. These dual basis functions have local support (over a patch of $6$ triangles in the two-dimensional case), ensure H(div)H(\mathrm{div}) conformity, and crucially:

  • Yield a diagonal (or sparse) mass matrix,
  • Permit computation of the discrete flux across an edge purely from the values of uTu_T in a local neighborhood,
  • Bridge the algebraic gap between finite element and finite volume methods.

The Petrov-Galerkin mixed FE scheme with dual RT test space reads: (pT,q)+(uT,divq)=0qHT(div,Ω), (divpT,v)+(f,v)=0vL2(Ω)T,(p_T, q^*) + (u_T, \operatorname{div} q^*) = 0 \quad \forall q^* \in H_T^*(\operatorname{div}, \Omega), \ (\operatorname{div} p_T, v) + (f, v) = 0 \quad \forall v \in L^2(\Omega)_T, where HT(div,Ω)H_T^*(\operatorname{div}, \Omega) is spanned by the dual basis.

A local flux formula in this context takes the form

SNuTnady=na(uLuK)+α(uMuL)+β(uPuK)+γ(uQuK)+δ(uRuL),\int_{SN} \nabla u_T \cdot n_a\, dy = n_a \cdot (u_{L} - u_{K}) + \alpha (u_M - u_L) + \beta (u_P - u_K) + \gamma (u_Q - u_K) + \delta (u_R - u_L),

with indices K,L,M,P,Q,RK, L, M, P, Q, R specifying cells in the local edge patch and coefficients chosen for polynomial consistency.

4. Stability, Convergence, and Error Analysis

The analysis of the RT-MFEM leverages the abstract Babuska–Brezzi (inf-sup) theory for mixed finite elements. Essential ingredients include:

  • Coercivity and boundedness of bilinear forms,
  • An inf-sup condition guaranteeing unique solvability and stability, with mesh-regularity-dependent constants,
  • Sufficient conditions on the dual test functions (Petrov-Galerkin case), namely bounds of the form

Aq02(q,Πq)Bq02,(divq,divΠq)Edivq02,A \| q \|_0^2 \leq (q, \Pi q) \leq B \| q \|_0^2, \qquad (\operatorname{div} q, \operatorname{div} \Pi q) \geq E \| \operatorname{div} q \|_0^2,

where Π\Pi is the mapping between the RT and dual RT spaces.

For well-constructed RT spaces (and especially in the Petrov-Galerkin variant with adequate dual bases), the methods yield optimal first-order error estimates in H(div)H(\mathrm{div}) for the flux and L2L^2 for the potential variable: uuTL2+ppTH(div)ChfL2.\|u - u_T\|_{L^2} + \|p - p_T\|_{H(\mathrm{div})} \leq C h \|f\|_{L^2}. These estimates are robust under mesh refinement and regularity assumptions.

5. Finite Volume Interpretation and Algebraic Equivalence

A foundational result is the algebraic equivalence of the RT-MFEM with specific finite volume schemes under certain constructions. When the dual RT basis is carefully built, the Petrov-Galerkin mixed formulation is shown to be equivalent to the "VF4" finite volume scheme of Faille, Gallouët, and Herbin, and to mass-lumping approaches (as in Baranger, Maître, Oudin). In these, the discrete flux across an edge becomes: pa=uLuKca,p_a = \frac{u_L - u_K}{c_a}, where cac_a depends on the cotangents of mesh angles adjacent to the edge. This structural parallel ensures that discrete gradients and numerical fluxes are computed locally, using only neighboring cell values—a key property of finite volume methods and essential for simulating conservation-dominated phenomena.

6. Computational and Practical Implications

The RT-MFEM supports implementation and deployment in a range of applied settings:

  • Sparse, local linear systems resulting from Petrov-Galerkin variants foster computational efficiency,
  • Applicability to general triangulations with rigorous error control,
  • Integration into finite volume codebases for engineering fields (petroleum, environmental, nuclear storage modeling),
  • Flexibility for hybrid and multiphysics discretizations, linking finite element and finite volume communities.

Construction of dual RT bases involves local algebraic systems and can be technically complex for general meshes or higher dimensions. The proven stability and error bounds, however, are retained as long as key properties (local support, L2L^2-orthogonality, polynomial consistency) are preserved.

7. Advantages, Applications, and Future Directions

The RT-MFEM (and its Petrov-Galerkin variants) offers the following advantages:

  • Local conservation and physical interpretability through matching of fluxes and mean-values,
  • Rigorous mathematical foundation ensuring convergence (via Babuska–Brezzi theory),
  • Algebraic simplicity and computational locality when dual test functions are correctly constructed,
  • Seamless bridging to established finite volume methods.

Common applications include diffusion-dominated PDEs, porous media flow, and any context where conservation and flux accuracy are paramount.

Ongoing and future work aims at:

  • Generalizing explicit dual RT construction to three dimensions and more complex geometries,
  • Furthering the connection to volume-consistent finite difference and mass-lumped mixed methods,
  • Extending the framework to multi-physics and multiphase problems, where hybrid discretizations are required.

Summary Table: Core Formulas and Interpretations

Formula Interpretation
(φa,φb)=δab(\varphi_a, \varphi_b^*) = \delta_{ab} Duality of primal and dual RT basis
pa=uLuKcap_a = \frac{u_L - u_K}{c_a} Local flux formula (finite volume equivalent)
Error: uuTL2+ppTH(div)ChfL2\|u-u_T\|_{L^2} + \|p-p_T\|_{H(\mathrm{div})} \leq Ch \|f\|_{L^2} Optimal first-order convergence

The Raviart–Thomas mixed finite element method constitutes a central computational approach for the simulation of elliptic and conservation-law-driven problems, integrating the mathematical rigor of finite elements with the physical and computational advantages of finite volume strategies, particularly via Petrov-Galerkin and dual-basis variants.