A multigrid ghost-point level-set method for incompressible Navier-Stokes equations on moving domains with curved boundaries

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

Highlights

  • A finite-difference ghost-point method to solve Navier-Stokes equations in complex-shaped moving domains is proposed.

  • The method is second order accurate.

  • The accuracy is not affected by moving domains or complex-shaped objects.

  • A proper geometric multigrid approach is presented, whose efficiency is not affected by complex-shaped moving objects.

Abstract

In this paper we present a numerical approach to solve the Navier-Stokes equations on moving domains with second-order accuracy. The space discretization is based on the ghost-point method, which falls under the category of unfitted boundary methods, since the mesh does not adapt to the moving boundary. The equations are advanced in time by using Crank-Nicholson. The momentum and continuity equations are solved simultaneously for the velocity and the pressure by adopting a proper multigrid approach. To avoid the checkerboard instability for the pressure, a staggered grid is adopted, where velocities are defined at the sides of the cell and the pressure is defined at the centre. The lack of uniqueness for the pressure is circumvented by the inclusion of an additional scalar unknown, representing the average divergence of the velocity, and an additional equation to set the average pressure to zero. Several tests are performed to simulate the motion of an incompressible fluid around a moving object, as well as the lid-driven cavity tests around steady objects. The object is implicitly defined by a level-set approach, that allows a natural computation of geometrical properties such as distance from the boundary, normal directions and curvature. Different shapes are tested: circle, ellipse and flower. Numerical results show the second order accuracy for the velocity and the divergence (that decays to zero with second order) and the efficiency of the multigrid, that is comparable with the tests available in literature for rectangular domains without objects, showing that the presence of a complex-shaped object does not degrade the performance.

Introduction

Navier-Stokes equations are a system of partial differential equations (PDEs) describing the motion of an incompressible viscous fluid subject to external forces. In the non-dimensional form, they readut+uu+p=1Re2u+fu=0 where u is the fluid velocity, p is the pressure, Re is the Reynolds number and f the external force. The first equation is obtained from the momentum equation, while the second one is the continuity equation and represents the incompressibility condition. Navier-Stokes equations have been central to innumerable scientific and engineering applications for several decades, as the necessity to model the motion of incompressible fluids has a tremendous impact on the real-life world. Several numerical approaches have been developed so far to provide efficient and accurate methods in different contexts, both for time and space discretization. An overview on traditional methods can be found in [43].

One of the first approaches for time discretization was the projection method, proposed by Chorin in [14]. It consists of a fractional step, where the velocity u is advanced in time by discretising the momentum equation and ignoring the pressure term, obtaining an intermediate velocity u. This velocity is not divergence-free, and therefore is corrected by the pressure term, that is determined by enforcing the divergence-free condition. Projection methods have been very popular for Navier-Stokes equations and are widely adopted nowadays, as they are computationally efficient and easy to implement (they require the solution of a sequence of elliptic equations for the intermediate velocity and for the pressure). However, the definition of boundary conditions for u and p is not obvious and it is challenging to achieve an accuracy higher than first order, even if the internal equations are discretized with higher order. There are existing approaches that suggest appropriate boundary conditions to improve the accuracy, as described in [11]. However, these boundary conditions are fully coupled each other and the resulting elliptic equations for u and for p cannot be solved in sequence, as the boundary condition on p depends on u.

Another approach consists of discretising both PDEs of Eq. (1) and solve them simultaneously in the unknowns (u,p). This is the monolithic approach and has the advantage that no boundary conditions are required for the pressure, as described, for example, in [61, Sect. 8.1]. These methods can usually achieve higher order accuracy than projection methods, but they have the disadvantage that extra computational effort is needed to solve both PDEs simultaneously. This aspect can be alleviated if efficient approaches are adopted such as the monolithic solver for fluid/solid interactions proposed in [35], where the authors achieve second order accuracy by maintaining a symmetric positive definite discretization.

Projection and monolithic methods refer only to time discretization and then spatial discretization methods must be addressed regardless of the choice between the methods described above. Standard problems on rectangular domains are usually discretized in space by using a finite volume approach on a staggered grid (MAC grid, see for example [59]), where the velocities are defined at the edges of the cell and the pressure is defined at the centre. The MAC grid is used for example to avoid the checkerboard instability for the pressure term observed in non-staggered grids due to the fact that p appears in the equations only in the form of ∇p. The extension of MAC grids to non-rectangular domains (curved boundaries) is not straightforward, since a particular treatment is needed close to the boundary. Moreover, there is an increasing scientific interest to Navier-Stokes equations for complex-shaped (possibly moving) domains, for example to model the motion of incompressible fluids around a deforming object, that may be central to more sophisticated applications such as fluid-structure interactions. Numerical methods for steady complex-shaped objects are mainly divided between fitted and unfitted boundary methods. In fitted boundary methods, the grid, either structured or unstructured (such as Finite Element Methods (FEM)), is adapted to the curved boundary [58], [38], [36], [47], [46], [25], [24]. Although they provide an extremely accurate representation of the domain, the generation of the mesh may become cumbersome and significantly expensive from a computational point of view, especially in moving domain problems where a new mesh generation is needed at each time step. In unfitted boundary methods the moving domain is instead embedded in a fixed grid. The methods of this class are based either on FEM, such as XFEM [40], [55] or GFEM [15], on meshless methods [62], or Cartesian meshes, such as cut cell methods [37].

An alternative approach of finite–difference methods for curved boundaries is represented by the Ghost–Point method. A pioneering work of this class of methods is the Immersed Boundary Method [54] to model blood flows in the heart, where Peskin presented a first-order accurate method, later extended to higher order by the Immersed Interface Methods proposed by LeVeque and Li in [44]. More recent finite-difference methods to discretize PDEs on complex domains are the Ghost-Fluid Methods proposed in [30], [33], [34], [50], where the grid points external to the domain are called ghost points and a fictitious (ghost) value of the numerical solution is formally extrapolated onto these grid points in order to maintain a stable algorithm and achieve the desired accuracy order. The main feature of these methods is that the internal equations are firstly formally solved for the ghost values, resulting in a final linear system with eliminated boundary conditions. This class of methods may fail to obtain high accuracy for Neumann boundary condition, and anyway it remains first order accurate in the post-processing reconstruction of the gradient of the solution.

A new finite-difference method with an improved accuracy was proposed by the author and Russo in [20], [22], [19] for elliptic equations and extended to thermo-poroelastic Cauchy-Navier equations for elastic deformation [17], Euler equations for gas dynamics [13], [21], electron transport in semiconductors [48], [49], fluid flow in porous media for water-rock interaction [18], [16]. In this approach, the ghost point values are eventually coupled each other, resulting in a bigger linear system with non-eliminated boundary conditions, solved by a multigrid approach suitably designed for ghost-point methods. The domain is implicitly described by a level-set function.

Other numerical methods to solve sharp-edge boundary problems are the finite volume methods, the non-symmetric positive definite finite element method, the matched interface and boundary (MIB) method [63], the arbitrary Lagrangian Eulerian method (ALE) [31], [27], the penalization methods [42], [5], [12], and the class of Immersed Finite Volume Methods (IFVM) [29]. Other recent advances have been obtained in [41] to achieve higher accuracy in the presence of Neumann boundary conditions, in [9] to solve elliptic interface problems with discontinuous coefficients, in [28] to solve sharp interface conditions and in [8], [6], [53] to obtain higher accuracy in the gradient of the solution.

Time and space discretizations of Navier-Stokes equations lead to a linear system that must be solved efficiently. Multigrid method is one of the most efficient iterative approaches to solve the linear systems arising from the discretization of a class of PDEs. Initially designed for elliptic problems, multigrid methods have been widely adopted to solve countless problems [61], [39], [10]. Several approaches have been proposed for boundaries aligned with grid lines. As example, we mention [4], [26], [3], [45], [1]. These approaches fall under the class of geometric multigrid, since the operators are defined from the geometrical background of the problem. An extension of geometric multigrid is represented by the class of algebraic multigrid methods [60], where the operators are defined merely from the information gathered from the linear systems, and therefore it is more practical for complex problems such as curved boundaries. However, the inclusion of geometrical information to the definition of the operators usually results in a more efficient solver, as highlighted for example in [2], where a comparison between geometric and algebraic multigrid methods for curved boundaries is performed.

In this paper, we provide a finite-difference method to solve the Navier-Stokes equations on moving domains following a monolithic approach for the time discretization and a finite-difference ghost-point method for the space discretization. The singularity of the problem (due to the fact that p is not uniquely defined, since it appears only in terms of ∇p) is circumvented by an additional equation for the pressure that requires that its average is zero. This additional equation is balanced with an additional unknown ξ that measures the average divergence of the velocity (that is therefore not necessarily zero, as in traditional methods, but decays with the same order of accuracy of the method). The linear system arising from the discretization is solved by a geometric multigrid approach, where the relaxation, restriction and interpolation operators are modified close to the boundary in order to maintain the same efficiency that standard multigrid techniques achieve away from the boundary.

The paper is structured as follows. In Sect. 2 and 3 we describe the time and space discretizations, respectively. The multigrid technique is detailed in Sect. 4, while numerical tests are provided in Sect. 5 and conclusions in Sect. 6.

Section snippets

Discretization in time

The Navier-Stokes equations (1) are discretized in time using Crank-Nicholson and solved for un+1 in the domain Ω(n+1)u(n+1)u(n)Δt+(uu)(n+1/2)+p(n+1/2)=12Re(2u(n)+2u(n+1))+f(n+1/2) in Ω(n+1)u(n+1)=0 in Ω(n+1)u(n+1)|Ω(n+1)=ub Taking the implicit terms on the left hand side and the explicit terms on the right hand side and multiplying by Δt, Eq. (2) reads:u(n+1)Δt2Re2u(n+1)+Δtp(n+1/2)=f˜Δt(uu)(n+1/2)u(n+1)=0u(n+1)|Ω(n+1)=ub where f˜=u(n)+Δt2Re2u(n)+Δtf(n+1/2). The first

Discretization in space

In this section we describe the space discretization of the equations, with particular attention to the treatment of the curved boundary using a fixed grid and a ghost-point approach. We describe the method in 2D for simplicity, although the approach can be straightforwardly extended to 3D as it does not rely on two-dimensional aspects.

An arbitrary domain Ω can be represented in different ways. For example, it can be represented explicitly by the parametric equations that describe the boundary

Multigrid approach

The linear system obtained in Sect. 3 and described in Algorithm 2 can be summarised as(IhuαLhu0(Dx)hu0Bhu0000IhvαLhv(Dy)hv00Bhv00(Dx)hp(Dy)hp01001h0)(uhvhphξ)=(f˜huubf˜hvvb00),or in a compact form:Mhuh=bh, where Ihu,v is the identity matrix, Lhu,v is the discretization of the Laplacian operator, Bhu,v the discrete boundary condition operators, (Dx,y)hu,v,p the central difference operator for the first derivative, and 1h a vector of ones.

This is a sparse non-symmetric linear system, whose

Numerical tests

In this section we perform several numerical tests to assess the accuracy of the discretization and the efficiency of the multigrid. The computational domain is D=(1,1)2 and the fluid domain is Ω=D\R(t), where R(t) represents the object at time t, described by a level-set function (Sect. 3.1). Different shapes will be tested: circle, ellipse and flower-shaped, defined at time t=0 as follows (see Fig. 6): For steady domains, the object will remain steady for the entire simulation, i.e. R(t)=R(0)

Conclusion

We have presented a numerical method to solve the Navier-Stokes equations in a moving domain. The equations are discretized by Crank-Nicholson in time and finite differences in space. The moving domain is described by a level-set function and the curved boundaries are discretized by a ghost-point method. The resulting linear system is solved by a multigrid approach properly developed for curved boundaries. The method is second order accurate in space and time. Several tests are provided,

Declaration of Competing Interest

The authors declare that they have no known competing financial interests or personal relationships that could have appeared to influence the work reported in this paper.

Acknowledgements

The author thanks Giovanni Russo for the precious suggestions. The work has been partially supported by the London Mathematical Society Computer Science Small Grants – Scheme 7 (Ref. SC7-1617-02) and the Research in Pairs – Scheme 4 (Ref. 41739).

References (63)

  • J. Dendy

    Black box multigrid

    J. Comput. Phys.

    (1982)
  • J. Donea

    An arbitrary Lagrangian-Eulerian finite element method for transient fluid-structure interactions

    Comput. Methods Appl. Mech. Eng.

    (1982)
  • R. Egan et al.

    xGFM: recovering convergence of fluxes in the ghost fluid method

    J. Comput. Phys.

    (2020)
  • R.E. Ewing et al.

    The immersed finite volume element methods for the elliptic interface problems

    Math. Comput. Simul.

    (1999)
  • R. Fedkiw et al.

    A non-oscillatory Eulerian approach to interfaces in multimaterial flows (the ghost fluid method)

    J. Comput. Phys.

    (1999)
  • L. Formaggia et al.

    Stability analysis of second-order time accurate schemes for ALE-FEM

    Comput. Methods Appl. Mech. Eng.

    (2004)
  • F. Gibou et al.

    A second-order-accurate symmetric discretization of the Poisson equation on irregular domains

    J. Comput. Phys.

    (2002)
  • F. Gibou et al.

    A fourth order accurate discretization for the Laplace and heat equations on arbitary domains, with applications to the Stefan problem

    J. Comput. Phys.

    (2005)
  • F. Gibou et al.

    Efficient symmetric positive definite second-order accurate monolithic solver for fluid/solid interactions

    J. Comput. Phys.

    (2012)
  • N. Gokhale et al.

    A dimensionally split Cartesian cut cell method for the compressible Navier–Stokes equations

    J. Comput. Phys.

    (2018)
  • Á. Helgadóttir et al.

    Imposing mixed Dirichlet–Neumann–Robin boundary conditions in a level-set framework

    Comput. Fluids

    (2015)
  • D. Lacanette et al.

    An Eulerian/Lagrangian method for the numerical simulation of incompressible convection flows interacting with complex obstacles: application to the natural convection in the Lascaux cave

    Int. J. Heat Mass Transf.

    (2009)
  • H.P. Langtangen et al.

    Numerical methods for incompressible viscous flow

    Adv. Water Resour.

    (2002)
  • A. Lozovskiy et al.

    A quasi-Lagrangian finite element method for the Navier–Stokes equations in a time-dependent domain

    Comput. Methods Appl. Mech. Eng.

    (2018)
  • A. Masud et al.

    A space-time Galerkin/least-squares finite element formulation of the Navier–Stokes equations for moving domain problems

    Comput. Methods Appl. Mech. Eng.

    (1997)
  • Y.T. Ng et al.

    An efficient fluid-solid coupling algorithm for single-phase flows

    J. Comput. Phys.

    (2009)
  • J. Papac et al.

    A level set approach for diffusion and Stefan-type problems with Robin boundary conditions on quadtree/octree adaptive Cartesian grids

    J. Comput. Phys.

    (2013)
  • C.S. Peskin

    Numerical analysis of blood flow in the heart

    J. Comput. Phys.

    (1977)
  • D. Peterseim et al.

    Finite element methods for the Stokes problem on complicated domains

    Comput. Methods Appl. Mech. Eng.

    (2011)
  • R.K. Shukla et al.

    Very high-order compact finite difference schemes on non-uniform grids for incompressible Navier–Stokes equations

    J. Comput. Phys.

    (2007)
  • K. Stüben

    A review of algebraic multigrid

  • Cited by (20)

    View all citing articles on Scopus
    View full text