Anisotropic mesh adaptation for continuous finite element discretization through mesh optimization via error sampling and synthesis

https://doi.org/10.1016/j.jcp.2020.109620Get rights and content

Highlights

  • DOF efficiency of Continuous FEM realized in adaptive context.

  • Optimal mesh anisotropy demonstrated for CG.

  • Nodal error models exploit continuity of basis functions.

  • Algorithm uses edge–based local solve patches.

Abstract

Anisotropic output-based mesh adaptivity is a powerful technique for controlling the output error of finite element simulations, particularly when used in conjunction with higher-order discretization. The Mesh Optimization via Error Sampling and Synthesis (MOESS) algorithm makes use of the continuous mesh model which encodes local mesh sizing and anisotropy in a Riemannian metric field, and was developed for Discontinuous Galerkin (DG) discretization. In this paper, we outline an extension of the MOESS algorithm for discretizations which are defined by basis functions that are continuous across element boundaries. Error models are defined in terms of local error estimates defined at vertices, and local solutions are computed on local patches defined in terms of the edges of the mesh. The resulting algorithm displays reduced error for the same number of degrees of freedom compared to the MOESS algorithm for DG discretization, as illustrated by some numerical examples for L2 projection and linear advection diffusion.

Introduction

Modern computational architectures have given rise to a drastic increase in the complexity of numerical simulations performed on a regular basis. As the complexity of these simulations has increased, the requirement to control errors within these simulations has increased commensurately. Output-based estimation enables the quantifiable control of error in measures more useful to scientific and engineering applications than typical residual norms. For instance the drag or heat flux on a boundary, or the average temperature or species consumption within a volume.

The Dual-Weighted Residual (DWR) framework developed for the Galerkin Finite Element Method (FEM) by Becker and Rannacher [1] provides a localizable estimate of the error in these quantities. The DWR estimate has been analyzed for other discretization methods by Carson et al. [2] and extended to other localization methods by Richter and Wick [3]. Another approach to output error estimation within FEM is the implicit estimation approach. Patera and Peraire utilize the coercivity of PDEs to bound the output with respect to the solution on a ‘truth’ mesh [4]. This technique was extended by Sauer-Budge et al. to bounding the computed output with respect to the true output [5], [6].

An initial approach to anisotropic adaptive algorithms for simplices used the Hessian of the solution, which controls linear interpolation error [7], [8]. This approach was codified in the work of Loseille and Alauzet [9], [10] who introduce the concept of mesh-metric duality and provide interpolation error estimates. In the case of a system of equations, the Hessian of a scalar derived quantity is used, for instance the Mach number for a fluid dynamics simulation. Alauzet and Loseille give a comprehensive review of the development of anisotropic adaptivity [11].

Various approaches for output-based anisotropic adaptation have been proposed. Venditti and Darmofal constructed a Hessian of a scalar component of the solution [12]. Fidkowski and Darmofal [13] and Leicht and Hartmann [14] extended this approach to higher order discretizations and Formaggia et al. used the Hessian of the dual [15], [16]. Loseille et al. applied mesh-metric duality to goal-based adaptation for the Euler equation by weighting the interpolation error of the fluxes by the dual [17]. Though successful these methods exhibit shortcomings, with the anisotropy detection being restricted to either primal or dual features alone, or only single components of multi-variable systems. Fidkowski and Darmofal provide a review of output error estimation and mesh adaptation in the context of computation fluid dynamics [18].

Driving adaptive decisions using local solves has been done by Houston et al. [19] and Ceze and Fidkowski [20] for quad-based meshes utilizing hanging nodes. Richter [21] and Leicht and Hartmann [22] used the quad/hex structure to pose discrete optimization problems. Yano and Darmofal used a local sampling process on simplex meshes to develop the MOESS algorithm [23]. MOESS consists of building surrogate models for the effect of local mesh perturbations on the global error via local sampling, then optimizing these models before re-meshing. The MOESS algorithm has proven particularly successful for aerodynamic applications where the physics are largely advection-dominated [24], [25]. Fidkowski proposed an alternative to the local sampling procedure of Yano and Darmofal, using projection of the higher-order adjoint between locally divided meshes to simulate local sampling [26].

The local sampling process of MOESS was developed particularly for the Discontinuous Galerkin (DG) discretization, though it can be naturally extended to any discretization with an elementally localizable estimate and discontinuous basis functions. One shortcoming of the DG discretization is the large number of degrees of freedom that come from duplication on element boundaries. This contrasts with the classical Continuous Galerkin (CG) discretization where basis functions are shared by adjacent elements. These shared degrees of freedom though efficient, prevent the application of the MOESS algorithm to this class of discretizations. MOESS has been extended to the Embedded Discontinuous Galerkin (EDG) discretization where Fidkowski distributed the error associated with the continuous features to the surrounding elements [27], thus the modeling process remains fundamentally elemental in nature. A comparison of MOESS algorithms for continuous and discontinuous discretizations, as applied to aerospace applications was shown by Carson et al. [28]

In this paper, we present a new MOESS class algorithm that works with discretizations that share degrees of freedom amongst elements, thereby enabling the design of anisotropic output adapted meshes for CG discretizations. For simplicity of exposition we consider here only the classic unstabilized CG discretization, though there is no fundamental difference to the algorithm when adding the stabilization necessary for more complex partial differential equations.

The outline of the paper is as follows: Section 2 introduces the metric optimization framework along with the notion of mesh-metric duality and the necessary machinery for manipulation of a metric field. Section 3 describes the MOESS algorithm for discontinuous-type discretizations. Section 4 outlines a new MOESS algorithm for continuous-type discretizations utilizing vertex-based local error models. Section 5 demonstrates the new algorithm in comparison to the original discontinuous-type algorithm for L2 error control in two dimensions. Section 6 outlines the vertex localized Dual-Weighted Residual output error estimate. Section 7 compares the algorithm to the original MOESS algorithm for a three dimensional linear advection diffusion PDE.

Section snippets

Metric optimization

The problem of finding an optimal mesh can be abstractly written asT=arg infTT(Ω)E(T)s.tC(T)C, where T(Ω) is the space of conforming meshes of the domain Ω, E is an error functional to be minimized and C is a cost functional that constrains the optimization. As an example E might be the L2 error computed using a discretization and C the number of degrees of freedom in the discretization.

Discrete optimization is relatively intractable, so in order to solve equation (2.1a), (2.1b) we consider

Mesh optimization via error sampling and synthesis

The MOESS algorithm aims to approximately solve equation (2.3a), (2.3b) by optimizing a sum of local surrogate models. Rather than optimizing M(x) directly, these models are posed in terms of perturbations to the current implied metric, {Mv}, in the form of a set of step matrices {Sv}. In this section we outline the formulation of these local models and the resulting optimization statement.

MOESS for continuous discretization

The MOESS algorithm as outlined in Section 3 is generally discretization agnostic with one major exception: the local solve process. In order to differentiate this from the approach described in this section, we denote the preceding approach discontinuous-type MOESS or D-MOESS. This contrasts with the approach outlined in this section, continuous-type MOESS or C-MOESS.

To localize the error functional we use the linear ‘hat’ functions ϕv(xv)=δv,v,v,vV(T) as a partition of unity, motivated

L2 error control

In this section we demonstrate the ability of the C-MOESS algorithm to produce optimal meshes for the control of L2 error, in comparison to D-MOESS. The problem of L2 error control is particularly well suited for verification as: (1) for DG discretizations the error is truly localized and (2) for D-MOESS the local solver is exact. Thus the C-MOESS algorithm can be compared to the D-MOESS algorithm in a setting in which D-MOESS should perform optimally. The metric mesher used to generate the

A-posteriori output error estimation

In this section, we demonstrate output-based adaptation using the Dual-Weighted Residual (DWR) method [1], building on the work of Richter and Wick [3]. We demonstrate it here for the unstabilized Continuous Galerkin discretization, however the method can be extended to any adjoint consistent stabilized CG method.

We restrict ourselves to linear output functionals of the form J(v)=Ωg(x)v+Ωb(x)F(v)nˆ and linear scalar PDEs, but the extension to non-linear functionals and systems of PDEs can

Linear Advection-Diffusion (AD)

To demonstrate the performance of the algorithm we introduce the scalar linear Advection-Diffusion (AD) system in three dimensions(auνu)=0, where aR3 is the advective velocity and νR+ is the viscosity. The domain of interest is defined as Ω[0,1]×[0,1]×[0,1], and we apply Dirichlet boundary conditions on ∂Ω taken from an exact solutionu(x)=1i=1d1eai(1xi)ν1eaiν. As a result of this tensor product of one dimensional boundary layers, we refer to this function as the triple boundary

Declaration of Competing Interest

There are no conflicts of interest for any of the authors.

The authors declare the following financial interests/personal relationships which may be considered as potential competing interests: Research agreements with/funding from The Boeing Company, Saudi Aramco and NASA.

Acknowledgements

This research was supported through research agreements with: The Boeing Company, technical monitor Dr. Mori Mani; NASA grant number NASA NRA NNX15AU39A, technical monitor Dr. Michael Park; and Saudi Aramco, technical monitor Dr. Ali Dogru.

References (41)

  • R. Becker et al.

    A feed-back approach to error control in finite element methods: basic analysis and examples

    East-West J. Numer. Math.

    (1996)
  • H.A. Carson et al.

    Analysis of output-based error estimation for finite element methods

    Appl. Numer. Math.

    (2017)
  • T. Richter et al.

    Variational localizations of the dual weighted residual estimator

    J. Comput. Appl. Math.

    (2015)
  • A.T. Patera et al.

    A general Lagrangian formulation for the computation of a-posteriori finite element bounds

  • A.M. Sauer-Budge et al.

    Computing bounds for linear functionals of exact weak solutions to the advection-diffusion-reaction equation

    SIAM J. Sci. Comput.

    (2004)
  • A.M. Sauer-Budge et al.

    Computing bounds for linear functionals of exact weak solutions to Poisson's equation

    SIAM J. Numer. Anal.

    (2004)
  • J. Peraire et al.

    Adaptive remeshing for compressible flow computations

    J. Comput. Phys.

    (1987)
  • M.J. Castro-Díaz et al.

    Anisotropic unstructured mesh adaptation for flow simulations

    Int. J. Numer. Methods Fluids

    (1997)
  • A. Loseille et al.

    Continuous mesh framework part I: well-posed continuous interpolation error

    SIAM J. Numer. Anal.

    (2011)
  • A. Loseille et al.

    Continuous mesh framework part II: validations and applications

    SIAM J. Numer. Anal.

    (2011)
  • F. Alauzet et al.

    A decade of progress on anisotropic mesh adaptation for computational fluid dynamics

    Comput. Aided Des.

    (2016)
  • D.A. Venditti et al.

    Anisotropic grid adaptation for functional outputs: application to two-dimensional viscous flows

    J. Comput. Phys.

    (2003)
  • K.J. Fidkowski et al.

    A triangular cut-cell adaptive method for higher-order discretizations of the compressible Navier-Stokes equations

    J. Comput. Phys.

    (2007)
  • T. Leicht et al.

    Anisotropic mesh refinement for discontinuous Galerkin methods in two-dimensional aerodynamic flow simulations

    Int. J. Numer. Methods Fluids

    (2008)
  • L. Formaggia et al.

    An anisotropic a-posteriori error estimate for a convection-diffusion problem

    Comput. Vis. Sci.

    (2001)
  • L. Formaggia et al.

    Anisotropic mesh adaptation in computational fluid dynamics: application to the advection–diffusion–reaction and the Stokes problems

    Appl. Numer. Math.

    (2004)
  • A. Loseille et al.

    Fully anisotropic goal-oriented mesh adaptation for 3D steady Euler equations

    J. Comput. Phys.

    (2010)
  • K. Fidkowski et al.

    Review of output-based error estimation and mesh adaptation in computational fluid dynamics

    AIAA J.

    (2011)
  • P. Houston et al.

    Adaptivity and a posteriori error estimation for DG methods on anisotropic meshes

  • M. Ceze et al.

    Anisotropic hp-adaptation framework for functional prediction

    AIAA J.

    (2012)
  • Cited by (7)

    View all citing articles on Scopus
    View full text