We introduce semi-implicit Lagrangian Voronoi approximation (SILVA), a novel numerical method for the solution of the incompressible Euler and Navier–Stokes equations, which combines the efficiency of semi-implicit time marching schemes with the robustness of time-dependent Voronoi tessellations. In SILVA, the numerical solution is stored at particles, which move with the fluid velocity and also play the role of the generators of the computational mesh. The Voronoi mesh is rapidly regenerated at each time step, allowing large deformations with topology changes. As opposed to the reconnection-based Arbitrary-Lagrangian-Eulerian schemes, we need no remapping stage. A semi-implicit scheme is devised in the context of moving Voronoi meshes to project the velocity field onto a divergence-free manifold. We validate SILVA by illustrative benchmarks, including viscous, inviscid, and multi-phase flows. Compared to its closest competitor, the Incompressible Smoothed Particle Hydrodynamics method, SILVA offers a sparser stiffness matrix and facilitates the implementation of no-slip and free-slip boundary conditions.
1 INTRODUCTION
In computational fluid dynamics, Lagrangian methods are invaluable for their ability to handle complex deformations and material interfaces. The defining feature of Lagrangian methods is that the degrees of freedom of the spatial approximation follow the motion of the material, rather than being static with respect to a selected Eulerian frame of reference. Consequently, the (often problematic) nonlinear convective terms are absent, thus obtaining a family of numerical schemes which exhibit virtually no numerical dissipation at contact discontinuities and material interfaces. Moreover, individual particles or cells preserve their identity, facilitating the mass conservation and the implementation of sharp material interfaces.
Developing a mesh-based Lagrangian method is notoriously difficult because of the large deformations inherent to the fluid motion. This problem becomes particularly evident when considering flows with high vorticity or large velocity gradients, that stretch, twist or compress the control volumes until they get invalid, that is, with negative volumes. To overcome this problem, mesh optimization algorithms have been developed,1-4 aiming at improving the mesh quality by performing a sort of regularization of the shape of each single cell. If the moving mesh scheme belongs to the category of Arbitrary-Lagrangian-Eulerian (ALE) methods, in which the mesh motion can be driven independently from the fluid velocity, the stage of mesh optimization is referred to as rezoning. The rezoning step is directly embedded in the numerical scheme for direct ALE methods,5, 6 otherwise it must be followed by a remapping step in indirect ALE methods.7-9 These techniques are all based on the assumption that the optimization process does not change the topology of the underlying computational grid, hence posing a severe limit to the possibility of improving the mesh quality for complex configurations. Moreover, the mesh optimization stage has to be compatible with some physical requirements on the numerical solution, for example, contact discontinuities must remain untouched to ensure the sharp interface resolution of Lagrangian schemes. The most general solution to this difficulty, which allows to combine mesh optimization and Lagrangian mesh motion, is to allow for topology changes. This approach is also known as reconnection, that has been originally presented in Reference 10. The idea was to use a set of Lagrangian particles, that are used to define the computational tessellation without assuming a fix connectivity: indeed, the topology of the mesh was time dependent, so that at each time step the connectivity was established by defining the surrounding domains (or control volumes) in accordance to the current particle positions. This mesh was then used to discretize the equations written in Lagrangian form. More recent developments of this seminal idea are given by Free-Lagrange methods,11, 12 Re-ALE schemes,13, 14 and finite volume ALE methods.15, 16
Among many others, a well-established mesh-free Lagrangian method is the Smoothed Particle Hydrodynamics (SPH), developed in 1970s: see Reference 17 for a review. In the SPH framework, the continuum is replaced by a finite number of material points (particles), and the gradients of physical variables (like density and velocity) are approximated using convolution and a convenient set of kernel functions. No computational grid is used in the SPH framework, hence yielding high versatility in the simulation of large deformations of the continuum. Due to its particle nature, the SPH method avoids the mesh-related issues and it is exceptionally robust. Owing to this advantage, together with the simplicity of implementation, SPH boasts with wide range of applications in science and industry.18, 19 Nevertheless, compared to mesh-based approaches, the computational cost of SPH schemes associated to each degree of freedom is typically larger, since every particle needs to communicate with every neighbor within a certain radius (as specified by the smoothing length).20 Moreover, converging to the exact solution is challenging because the spatial step must shrunk faster than the smoothing length,21 leading to an unfavorable effective convergence rate. To remain competitive in this regard, the accuracy of SPH methods needs to be improved by relying on a set of renormalized operators,22, 23 typically at the expense of discrete energy conservation.24 Lastly, let us mention the problematic of boundary conditions. While free surfaces in fluids and solids are automatically handled, implementing Dirichlet or Neumann conditions in the SPH framework is less trivial (in comparison to e.g., Finite Element Method). As it turns out, having a mesh is not completely without merit and this is where Lagrangian Voronoi Methods (LVM) enter the game.
The study of Lagrangian methods based on Voronoi tessellations dates back to the 70s and 80s, for example, see Reference 11, and received further attention in the 90s, for example, see References 25-27, and in the light of recent publications.15, 16, 28, 29 By definition, a Voronoi cell is the set of points which is closer to the generating particle (seed) than to any other particle . The Voronoi mesh generated by moving particles has the advantage of keeping reasonably good quality even in case of large deformations. Furthermore, the local topology of Voronoi meshes can be arbitrary, thus this kind of mesh permits to remove some mesh imprinting that might arise from the adoption of the Lagrangian frame of reference.
While the aforementioned studies revolve around compressible fluids and use explicit time steps, in this paper, we introduce some implicitness to obtain a LVM variant for the incompressible Euler and Navier–Stokes equations. With the aim of avoiding the solution of globally implicit systems defined on the entire computational grid, the implicit-explicit (IMEX) approach has emerged in the literature30-36 as a powerful time integration technique which permits to split explicit and implicit fluxes.32, 33, 37 In particular, we rely on a semi-implicit time discretization,38-41 in which the mesh motion is treated explicitly while the pressure terms are taken into account implicitly. This is well suited to enforce the divergence-free condition on the velocity field, which is nothing but the energy equation for incompressible fluids.
To the best of our knowledge, such studies on semi-implicit schemes on Lagrangian Voronoi meshes did not receive sufficient attention in the literature. Yet, we found out that our method is conceptually similar to the method by Borgers and Peskin.42, 43 Namely, the spatial and time discretization of the governing equations is similar to Reference 43, however, the key novelties lay in the fast computation of the Voronoi mesh, and a novel stabilized pressure gradient allowing to efficiently deal with the tensile instabilities known for particle methods. Also, our method is linked with the recent work of Després,29 and it relies on the improved gradient approximation by Serrano and Espanol.44
The scheme presented here is termed Semi-Implicit Lagrangian Voronoi Approximation (SILVA), since the mathematical model is given by the incompressible Navier–Stokes equations. We will show that SILVA arises quite naturally from basic assumptions. The correctness and accuracy of the scheme is verified in benchmarks, including the lid-driven cavity problem and a Rayleigh–Taylor instability test for multi-phase fluids. Not only engineers and researchers interested in new Lagrangian numerical methods for fluid mechanics may find this paper valuable, but also SPH specialists because of the deep analogies between SILVA and incompressible SPH (ISPH). Both methods involve moving particles, are based on Helmholtz decomposition, and the cell-list structure from ISPH is a perfect tool for constructing a Voronoi grid for SILVA. To summarize, the two methods are highly inter-compatible and an implementation of a physical phenomenon in one method can be painlessly imported to the other one.
The structure of the paper is as follows. In Section 2, we present the governing equations of incompressible fluids, while in Section 3 we introduce the definition and notation of the moving Voronoi mesh, including its generation. Section 4 is devoted to the description of the numerical scheme, namely our LVM, with details on the explicit and the implicit time discretization as well as on the discrete spatial operators. The numerical validation of the accuracy and robustness of SILVA is presented in Section 5 by running several benchmarks for incompressible fluids. Finally, Section 6 finalizes this article by summarizing the work and giving an outlook to future investigations.
2 GOVERNING EQUATIONS
We consider a -dimensional domain closed by the boundary , with being the spatial coordinate vector and representing the time coordinate. In the Lagrangian frame, the mathematical model which describes the phenomena of incompressible viscous flows writes
(1a)
(1b)
(1c)
Here, identifies the velocity vector, denotes the pressure, and is the fluid density, is the kinematic viscosity of the fluid and
(2)
is the material derivative of a quantity . Equation (1c) is the so-called trajectory equation, which drives the motion of the coordinates and is the defining feature of a Lagrangian method.
The flow is incompressible, which implies that is constant along the flow trajectories, although it is not necessarily constant in space. The velocity field is subjected to the divergence constraint (1b), which can be reformulated in a weak sense. Indeed, by multiplying Equation (1b) by a smooth test function and integrating by parts over the domain , we have that
(3)
We will assume that the no-penetration condition is satisfied at the boundary
The condition (4) is not sufficient for a viscous fluid () which also requires a condition for the tangential velocity. Two possibilities will be covered in this manuscript: the free-slip and no-slip condition. We return to this topic in Section 4.5. It would be also possible to consider periodic boundaries, which would imply the use of a periodic Voronoi mesh generator. We do not foresee any substantial obstacle in this regard. The implementation of other conditions, like inflows and outflows, are left for future investigations.
3 MOVING VORONOI MESH WITH TOPOLOGY CHANGES
3.1 Notation and definitions
Let assume to be an open convex and bounded polytope. We consider distinct sample points , which will be treated as material points. The points are called seeds, for . A Voronoi cell corresponding to the seed is defined for every as
To make notation easier throughout the entire paper, we assume that the cell indexes are always running in the interval . In the Lagrangian framework, every cell contains a portion of fluid with mass , which is constant in time. The Voronoi cell is a convex polytope and its boundary is composed of the set of facets
(6)
Furthermore, the cell boundary might share a portion of the domain boundary when . In such case, we refer to as a boundary-touching cell, or an interior cell otherwise. We also define the surface element:
(7)
where is the outward pointing unit normal vector defined on .
The golden property of Voronoi meshes is the orthogonality between the facets and the segments joining two seeds, namely . Hence, the outer normal vector is simply given for each facet by
(8)
where represents the inter-seed distance. The -dimensional Lebesgue measure of each cell is denoted by , while is the -dimensional Hausdorff measure of its boundary. Likewise, represents the length of the facet . In general, it is necessary to distinguish the midpoint of a facet
(9)
and the inter-seed midpoint
(10)
Indeed, for a general Voronoi cell, it is possible that .
To evaluate partial derivatives in closed form for a Voronoi mesh, we refer to the recent developments forwarded in Reference 29. There is indeed a simple formula for computing the derivative of a Voronoi volume with respect to the other seeds,29 which is recalled in the following theorem.
Theorem 1.Forwe have the closed form formulae:
(11)
and
(12)
Proof.We present a two page proof using the Lebesgue (dominated convergence) theorem in A. Other proofs can be found in References 29 and 42, which rely on a smooth function to approximate the characteristic function of . Another derivation restricted to the two-dimensional case can also be found in Reference 43.
Remark 1.It is possible to get an intuitive understanding of (11) by evaluating the rate of change of volume when the seeds are moving. By the transport theorem we have
(13)
where is the speed of the interface in the outward normal direction with respect to . Naively, one would expect
(14)
Therefore, in the case when only is moving one obtains
(15)
As it turns out, this is true only when moves in a direction parallel to the vector , like during a linear stretching (and it is always true for a one-dimensional Voronoi mesh, where ). Formula (11) can be understood as a correction of (15) for displacements of that also contain transversal components to . To see this, take for example a rotational motion
(16)
where is a skew-symmetric matrix (with other seeds, including , being all fixed). It is easy to see that the plane of equidistance between and will also rotate with the velocity
(17)
Substituting this velocity field into the transport theorem (13), we find
(18)
Remark 2.We note that formula (11) fails when is nonconvex. This is quite a concerning limitation, which will require a special treatment in future studies. In this paper, all domains are rectangular.
3.2 Voronoi mesh generation
The problem of generating Voronoi meshes is well studied in the literature45 and Voronoi mesh generators have been implemented in a variety of open-source libraries, such as Qhull,46 Voro++47 or CGAL.48 Most of them rely on constructing the Delaunay triangulation, which is a topological dual of a Voronoi grid. However, for our LVM, it is important to have a fast algorithm for computing the Voronoi grid from the moving seeds at every time step. We found that a direct approach to compute Voronoi cells (i.e., avoiding the computation of the dual mesh) is preferable.49, 50 Such a method only involves the data from the nearest neighbors, that is, it can be considered as being local, and hence suits well to parallelization. We illustrate this iterative technique in Figure 1 for the first five iterations . In the first step, that is, for , every cell is initialized as . We then construct a cell list, which divides the computational domain into a finite number of partitions (squares in Figure 1) of size comparable to the spatial resolution (in this paper, we set the side length of those partitions to be ). For a given (green particle in Figure 1), we find the containing partition and proceed by generating an iterator through a sequence , of all other partitions in the cell list, sorted in ascending order by their distance to . Then, the polytopes
(19)
are constructed in an iterative process. Each has a radius , which is the distance between and the furthest vertex of . The iterative procedure stops when the Hausdorff distance between and satisfies
(20)
thus we set , as all remaining points are provably too remote and can be excluded from the computation.
A Voronoi cell for the green particle in the center can be obtained by intersecting half-planes, one for each other seed. The cell list structure optimizes the computation by focusing on nearby seed only. The orange and blue colors highlight the partition and the incomplete Voronoi cell , respectively, for . [Colour figure can be viewed at wileyonlinelibrary.com]
In the Lagrangian approach, the seeds are displaced with the fluid velocity. Therefore, the Voronoi mesh needs to be regenerated at each time step with possible changes in the mesh connectivity. Starting from the second time step, the process of mesh generation is further accelerated by initializing
(21)
where is the set of neighbors of from the previous mesh configuration. With this heuristics, the number of non-trivial half-plane cuts is reduced to bare minimum. In the context of numerical simulations on moving Voronoi tessellations, the method has the following advantages.
If is bounded, complexity is guaranteed in the mesh generation process.
Since the cell constructions are independent processes, the method can be easily parallelized.
This technique works both in two and three dimensions.
4 LAGRANGIAN VORONOI METHOD
In this section, we describe and analyze the discrete gradient operator on moving Voronoi grids for a generic smooth function. Then, we present the semi-discrete in space numerical scheme, and finally we provide the details of the semi-implicit time marching algorithm. For the sake of clarity, we first assume no viscous terms in the velocity equation (1a), hence focusing on the incompressible Euler model. Viscous forces will be consistently considered in the numerical scheme and presented at the end of this section.
4.1 Discrete gradient operator
Let us assume that is a smooth function defined on , and are its point values. In order to approximate , we use the following representation of the identity matrix:
(22)
which holds for every cell by virtue of the divergence theorem. For any interior cell , using the orthogonality between and the facet (see Equation 8) we obtain:
(23)
where . This is the definition of the discrete gradient operator . The only approximation occurs in the step
(24)
which is exact only for polynomials up to first degree. The following error estimate is from Reference 51, p. 804.
Theorem 2.Let , that is, is twice continuously differentiable, and let assumein two space dimensions. Then for any interior cellwe have that
and we get the desired result by combining this with a formula for the Voronoi cell volume:
(27)
Remark 3.Intriguingly, the error term does not depend on the mesh quality. We do not require to bound the number of facets or the ratios .
Remark 4.If the Voronoi mesh is rectangular with the sides and , then (23) becomes equivalent to the central finite difference operator
(28)
which has second order of accuracy. As we shall demonstrate in Section 5.1, it is possible to obtain a super-linear convergence in velocity if a rectangular grid is used in the initialization. This is understandable, because with decreasing spatial step, the mesh eventually becomes “locally rectangular” throughout the entire simulation time.
Remark 5.By adding a “clever zero”, we can obtain an alternative formulation (valid for interior cells):
(29)
where and is given by (10). This form of the gradient approximation is used in the work of Serrano et al.44 and Springel.15
Remark 6.For a boundary-touching cell, with the facet , an additional term must be considered:
(30)
For a Robin boundary condition of the type
(31)
it is reasonable to approximate the gradient as
(32)
Note that the extra term in (32) disappears for a homogeneous Neumann condition.
Next, we consider a different discretization of the gradient operator. This takes the form
(33)
which is motivated by the following “discrete integration by parts.”
Theorem 3.Letand , and let us consider the discrete gradient operators (23) and (33). The following identity holds true for :
(34)
Proof.Using the previously introduced definitions and some algebra, we find:
(35)
The second term on the right-hand side vanishes by virtue of anti-symmetry. The first term can be simplified using
(36)
hence the result.
We shall refer to (23) and (33) as strong and weak gradient, respectively. Unfortunately, our investigation reveals that the weak gradient is no longer first-order exact, but it exhibits an oscillatory nature and cannot be used to obtain reliable point-wise approximations of the continuous gradient operator, especially on highly irregular meshes. See Figure 2 for a comparison between the two gradient operators. The situation is similar to SPH, where a pair of gradient operators is defined, such that they satisfy a discrete integration by parts. Enforcing some degrees of exactness on one operator does not carry over to the other one.20
The magnitude of on a square with an irregular Voronoi grid of 6400 cells (A) for . The image (B) and (C) show exact solution and the strong gradient (23), respectively, and they are barely distinguishable. The image (D) uses the weak gradient (33) and is infested with spurious noise. (A) Mesh; (B) Exact; (C) Strong; (D) Weak. [Colour figure can be viewed at wileyonlinelibrary.com]
Nonetheless, the weak gradient is useful to derive the variation of the cell volume . By virtue of (12), we get
We consider the seeds of a moving Voronoi mesh being the material particles with point-values of velocity , density and pressure . The mathematical model is given by the velocity equation (1a), the divergence constraint in weak form (5), and the trajectory equation (1c). For the first exposition of the method we shall ignore the viscous terms and only include them later.
For each cell , a natural semi-discrete space discretization writes
(40a)
(40b)
(40c)
Theorem 4.Any solution of the semi-discrete scheme (40) satisfies the following properties.
The individual cell volumesare conserved:
(41)
The energy
(42)
is conserved.
Proof.Using the variation (39), the time evolution of is given by
(43)
Multiplication by a smooth test function and integration over all cells, leads to
(44)
Using the identity (34) and the semi-discrete divergence constraint (40b), from the above relation we find that
In light of the previous result we deduce that the cell volume does not depend on time, thus the time evolution of the total energy (42) yields
(46)
Inserting the balance of momentum (40a) and using the incompressibility constraint (40b), we obtain
(47)
4.3 Semi-implicit time discretization
The idea behind the semi-implicit time discretization for incompressible fluid is fairly standard, although it is not frequently applied in the context of LVM (we are aware of only43). It can be understood as Chorin iterations,52 or equivalently, the projection of the velocity field onto the solenoidal space in the sense of Helmholtz decomposition. This requires the solution of an implicit system on the pressure, globally defined on the entire computational domain, which is obtained by combining the velocity equation (1a) with divergence-free constraint (5). On the other hand, the mesh motion is explicit, using the trajectory equation (1c).
Let us consider the time interval , with and being the final time of the simulation. The time interval is discretized by a sequence of time steps , with denoting the current time. We proceed by introducing a semi-implicit time discretization for the semi-discrete scheme (40).
The Voronoi seed positions are advected explicitly by the velocity field, that is
(48)
and the Voronoi mesh is regenerated at the new time level , hence obtaining the new tessellation. All geometry related quantities can now be computed, for example, facet lengths , inter-seed distances and facet midpoints . As proven in Theorem 4, cell volumes are instead constructed to be constant in time, hence we simply have .
Even though this step does not modify the velocity per se, it introduces a non-vanishing divergence of the velocity field through the deformation of the mesh. Therefore, the velocity needs to be updated at the next time level by the correct pressure gradient, which can be interpreted as a Lagrangian multiplier enforcing the incompressibility constraint. To this aim, we impose that the new velocity and pressure satisfy
(49a)
(49b)
Formal substitution of the velocity equation (49a) into the divergence-free constraint (49b), yields an elliptic problem for the pressure
(50)
The associated system matrix is defined for any function and to satisfy the following relation:
(51)
thus the matrix is clearly symmetric. The right-hand side of (50) is an -element vector representing the linear functional
(52)
The coefficients of the system can be evaluated by setting and for fixed indexes . Unfortunately, the matrix is not very sparse because not only when are neighbors, but also when is a neighbor of .
In the case when the fluid is incompressible and homogeneous (), it is possible to sparsify the problem (51) through the following “approximation of approximation,” in a direct analogy to incompressible SPH. Recalling the strong gradient definition (23) and using the homogeneous condition , the system matrix in (51) is rewritten as follows:
(53)
The term involving disappears because of the anti-symmetry of the addends. The new matrix is thus defined such as
(54)
and it is much simpler, more sparse and still symmetric compared to the matrix in (51). Figure 3 depicts an illustration of the sparsity of when compared to incompressible SPH. SILVA produces much sparser matrices, which is a great advantage compared to SPH-based methods: for SILVA, the number of non-zeros per node is less than 7, but for SPH it is about 24. We expect that the difference becomes even more pronounced in three space dimensions. In the definition (54), we can recognize the approximation of the Laplacian operator as used in the Finite Volume Method on Voronoi meshes, which generalizes the standard central finite difference operator on Cartesian meshes.53 Since
(55)
we see that the matrix is positive semi-definite and singular, with kernel generated by a constant vector (since is connected). This implies that an additive constant on the pressure must be added to solve the Poisson problem with Neumann boundary conditions. Luckily, when we use a Krylov solver, like the Conjugate Gradient (CG) or the minimal residual (MINRES) method, this never becomes a real issue, since the matrix is regular in the invariant subspace of vectors with zero average. The right-hand side defined by (52) clearly belongs to this vector space, since
Example of a sparsity pattern of the left-hand-side matrix in semi-implicit Lagrangian Voronoi approximation (SILVA) and incompressible smoothed particle hydrodynamics (ISPH) on uniformly random distribution of 625 points (Voronoi seeds) in two dimensions. The smoothing length for ISPH is and the Wendland quintic kernel is used. For the sake of readability, the points are sorted by their occurrence in the cell list. (A) SILVA; (B) ISPH.
Once the new pressure field is determined, the divergence-free velocity field is readily updated by means of (49a).
Remark 7.As an alternative to (53) it could be possible to obtain a sparse matrix by adopting the staggered grid approach, along the lines of the semi-implicit finite volume schemes proposed in.38 We leave this option for future investigations.
In the SPH method, a well-known numerical artifact, called tensile instability, appears in regions with negative pressure and leads to undesirable clustering of particles.54 In a naive implementation of a LVM, a similar problem arises. Even if every sample point occupies the same area in the sense of the Voronoi mesh, this does not forbid the seeds to approach each other arbitrarily close, leading to stability issues. This problem is particularly evident near pressure minima (such as vortex cores). To shed some light on this problem, let us suppose that close to a seed , the pressure is given by
(57)
where is a positive constant. Then and the particle should not be accelerated. Unfortunately, this is not what we observe because at the discrete level, the strong gradient operator (23) applied to the above pressure filed yields
(58)
Indeed, a Voronoi cell can be divided into subcells (triangles for ), each of which is a convex hull of and has volume
where is the centroid of . Therefore, unless , the seed will be accelerated away from the centroid, hence distorting the cell. This means that we have to remove the potentially nonzero term given by . To determine the positive coefficient , let us compute the Laplacian of the pressure field (57), which leads to
(62)
The above expression is then inserted in (61) to obtain the following definition of a stabilized pressure gradient:
(63)
where is evaluated relying on the discrete Laplace operator (64), which will be introduced in the next section. Here, denotes the positive part of a function. We shall use (63) instead of in (49a) for the update of the velocity field. Note that this stabilizer does not introduce any numerical parameter nor does it interfere with the exactness of the discrete gradient on linear functions.
Other stabilization techniques for LVM are suggested in the literature and can be used also in our setting. In Reference 15, the clustering is prevented in the spirit of ALE method, by introducing a velocity of coordinates in the direction defined by the vector . In,29 a stabilizer is designed which adds a repulsion force nearby particles and is proven to be weakly consistent. We prefer to adopt the stabilizer (63) because it is relatively simple to implement and it preserves the fully Lagrangian nature of SILVA.
4.5 Discrete viscous operator
It remains to discretize the viscous terms in the velocity equation (1a). In a finite volume sense, the Laplacian of a twice differentiable vector field can be estimated as follows:
(64)
Using the above definition and assuming a constant kinematic viscosity coefficient , the viscous force in the incompressible Navier–Stokes model (1) can be easily implemented within each cell as
(65)
with . Naturally, if viscosity is included, we can no longer expect the conservation of energy in (42), since represents only the mechanical component of energy and does not take into account entropy production. However, the velocity field is still divergence-free and the cell areas are still preserved. Regarding the time discretization, we include the viscous force right after the advection step (48) in an explicit manner. In this way, we obtain an intermediate velocity field
(66)
which is then projected to a solenoidal space by the implicit pressure step (49) with in place of .
Remark 8.To prescribe a Dirichlet condition for the velocity vector of the type
(67)
on a linear boundary , we need to take into account the viscous force by which walls act onto Voronoi cells. The force can be introduced by means of a fictitious mirror polygon , which is the reflection of with respect to and which has velocity
(68)
Including these reflected cells, Equation (65) can be used without modification by setting . Following the same reasoning, no-slip boundary conditions are obtained by setting , which means .
4.6 Summary of the SILVA method
Finally, let us briefly summarize what one time step of SILVA looks like.
Update of the seed positions with (48), hence by solving explicitly the trajectory equation (1c).
Re-generation of the Voronoi mesh according to the procedure detailed in Section 3. Update of all geometry related quantities (facet lengths, midpoints and inter-seed distances).
Explicit computation of the viscous forces using (65).
Computation of the new pressure by implicitly solving the discrete pressure Poisson equation (50) with the matrix given by (54) and the right-hand-side vector given by (52) using the MINRES method.
Update of the divergence-free velocity field by means of (49a) with the stabilized pressure gradient (63).
5 NUMERICAL RESULTS
5.1 Taylor–Green vortex
We consider the Taylor–Green vortex benchmark on the computational domain . This test case has the analytical solution in the form of an exponentially decaying vortex with the velocity field given by
(69)
while the pressure field is
(70)
The total kinetic energy is
(71)
is the Reynolds number and it represents the ratio between inertial and viscous forces in the studied phenomenon. and are the reference velocity and domain size, respectively. A free-slip boundary and a compatible initial condition is prescribed. In accordance with Reference 41, the simulation is terminated at time , and we measure the energy conservation error as well as the error of pressure, velocity and the divergence of velocity, evaluated using the discrete operator (33). The mesh convergence is tested on two types of Voronoi meshes: one is initiated as a structured Cartesian mesh, while the other one as an unstructured mesh, see Figure 4. Three different values of Reynolds number are considered, namely , and the obtained convergence rates are depicted in Figure 5. The convergence tables to these graphs can be found in B. Compared to the results by Borgers & Peskin,43 we report a super-linear, rather than linear, convergence in velocity and we do not suffer any major issues in the inviscid case . However, we also observe a relatively larger error in the pressure field. The divergence of the velocity field is not conserved up to the machine precision, due to the adoption of a sparser matrix and algebraic errors, but has a very fast convergence rate.
The final time step of Taylor–Green Vortex for , . (A) Rectangular grid; (B) Unstructured grid. [Colour figure can be viewed at wileyonlinelibrary.com]
Errors of velocity, pressure, energy and velocity divergence in the Taylor–Green vortex benchmark. The horizontal axis corresponds to , where is the number of cells per side of the computational domain. The vertical axis indicates the logarithm of error. We also compare the result for a structured (ST) rectangular and an unstructured (UN) Vogel grid for . The dashed triangles indicate what the reference linear and quadratic convergence slopes. The convergence curves on unstructured grids are more erratic for unknown reasons. Nonetheless, the overall convergence rate is comparable. (A) Velocity error; (B) Pressure error; (C) Energy error; (D) Divergence error. [Colour figure can be viewed at wileyonlinelibrary.com]
5.2 Gresho vortex
The Gresho vortex problem is a standard test case for inviscid fluids. The initial conditions impose a vortex with a triangular velocity profile. With no viscosity, the flow field is stable under evolution, but this behavior is difficult to recover numerically. For the initial setup of this test, we refer to Reference 55. The computational domain is initially discretized with three different resolutions, namely with , and Voronoi seeds. The results of the simulation are depicted in Figure 6, and they indicate that SILVA preserves the triangular profile with reasonable accuracy, while exhibiting some diffusive behavior. Furthermore, mesh convergence with the respect to the loss of energy is shown. The color map of the velocity field is shown in Figure 7. Note that the final time corresponds to more than three full revolutions of the vortex, which would be clearly impossible to simulate on a Lagrangian mesh with fixed topology. Without using the stabilizer introduced in Section 4.4, we observe the well-known vortex core instability, as illustrated in Figure 8.
Left: comparison of the tangential velocity along the -axis with the exact solution in the Gresho vortex benchmark. The result is at and compares three different resolutions and an analytical solution. Right: time evolution of energy (relative to the initial state). The graph can be compared to the high-order semi-implicit method presented in Reference 33. [Colour figure can be viewed at wileyonlinelibrary.com]
Gresho vortex at . The color map indicates magnitude of velocity. A group of Voronoi cells is highlighted in green. In the last frame, the vortex structure is starting to deteriorate. The resolution in this figure is . [Colour figure can be viewed at wileyonlinelibrary.com]
Zoom at the vortex core at and with and without stabilization. The Voronoi mesh becomes distorted as seeds are propagated away from their respective centroids. (A) Initial state; (B) Unstable (). (C) Stabilized ().
5.3 Lid-driven cavity
To test the correct simulation of the viscous forces, we consider the lid-driven cavity problem for an incompressible fluid. The computational domain is given by , and the fluid is initially at rest, that is, and . No-slip wall boundary conditions are defined on the vertical sides () and at the bottom () of the domain, while on the top side () the velocity field is imposed. The simulations are performed as time-dependent problems on a Voronoi grid of 10,000 sample points, and four different Reynolds numbers are consider, namely . An excellent agreement with the notorious referential solution by Ghia et al.56 is achieved and plot in Figure 9. More precisely, the agreement for Reynolds numbers is almost perfect. At , we observe some discrepancy, presumably because of the numerical diffusion and insufficient resolution near boundary layers. However, SILVA is sufficiently precise to indicate subtle features of the flow, such as the left and right bottom corner vortices as well as the emergence of top left corner vortex for , see Figure 10. To emphasize the Lagrangian character of SILVA, Figure 11 shows the trajectories of some Voronoi cells.
Horizontal velocity along the vertical center-line (orange) and vertical velocity along the horizontal center-line (blue) in the lid-driven cavity benchmark computed using semi-implicit Lagrangian Voronoi approximation (SILVA) for various Reynolds numbers. We compare the result with the referential solution of Ghia et al.56 (A) Re = 100, ; (B) Re = 400, ; (C) Re = 1000, (D) Re = 3200, . [Colour figure can be viewed at wileyonlinelibrary.com]
Color-map of the velocity magnitude for . A group of Voronoi cells is highlighted in magenta. Some of these cells remain trapped in the corner vortex. (A) ; (B) ; (C) ; (D) ; (E) ; (F) . [Colour figure can be viewed at wileyonlinelibrary.com]
5.4 Rayleigh–Taylor instability
Finally, we present the simulation of a multiphase problem with SILVA, namely the Rayleigh–Taylor instability57 of an inviscid fluid without surface tension. Our setup is the same as in the SPH study presented in Reference 58. The domain is the rectangle which is discretized with 80,000 Voronoi seeds. The initial density field is given by
(72)
Two immiscible fluids of different densities are involved, which are separated by a curve described as
(73)
The densities correspond to Atwood number . The two fluids begin at rest, have identical viscosity and are subjected to a homogeneous gravitational field. The Reynolds number is and the Froude number is . No-slip boundary conditions are imposed on all sides of the domain.
This problem is concerned with an incompressible fluid but with a heterogeneous density field. Hence, the approximation (53) is no longer valid when we need to take into account the gradient of pressure. The correct discrete equation is now given by
(74)
The above system can be solved quite efficiently by means of fixed-point iterations, with denoting the current iteration number:
(75)
starting with . The iterative process stops when the condition is satisfied. Figure 12 displays the result of SILVA computation, which are in qualitative agreement with the ISPH solution.58 We also perform a mesh convergence study of this test for three different mesh resolutions (), and the results are depicted in Figure 13. We observe that the interface profile between the two immiscible fluids becomes increasingly more smooth, and the numerical artifacts disappear.
Snapshots of the Rayleigh–Taylor instability at output times . The lighter fluid is orange and the heavier is dark blue. The simulation contained 80,000 Voronoi cells. (A) ; (B) ; (C) . [Colour figure can be viewed at wileyonlinelibrary.com]
The Rayleigh–Taylor instability at for three different resolutions. is the number of Voronoi seeds per shorter side of the domain, so there are Voronoi seeds in total. (A) N = 60; (B) ; (C) . [Colour figure can be viewed at wileyonlinelibrary.com]
6 CONCLUSION
In this paper, a new LVM for the solution of the incompressible Navier–Stokes equations has been presented. The spatial discretization is carried out by means of moving Voronoi cells that are regenerated at each time step with an efficient cell-list-based Voronoi mesh generation technique, optimized for multithreaded time-dependent problems. To overcome the problem related to the vortex-core instability associated with the established LVM gradient operator, we have proposed a new stabilizing procedure, which is notable by the lack of numerical parameters and by preserving the exactness of linear gradients. A semi-implicit time discretization has been developed for the first time in the context of LVM, which discretizes explicitly the trajectory equation, that drives the mesh motion, and the viscous terms in the velocity equation. To enforce the projection of the velocity onto the associated divergence-free manifold, the velocity equation is inserted in the divergence-free constraint, yielding an implicit linear system for the pressure that corresponds to the well-known elliptic Poisson equation. The matrix of the system is provably symmetric and can therefore be solved with very efficient iterative linear solvers like the Conjugate Gradient method or MINRES. The accuracy of the scheme has been assessed in four different test-cases, featuring both viscous and inviscid fluids as well as multiphase flow. Linear convergence has been empirically studied in a Gresho vortex benchmark. Our novel scheme, referred to as SILVA, is able to run long-time simulations without any mesh degeneration, inspired by the so-called reconnection-based algorithms on moving meshes.
SILVA is an interesting alternative to the incompressible SPH method, because of the benefits coming from a sparser matrix associated to the elliptic Poisson system, and a relatively easy implementation of free-slip and Dirichlet boundary conditions. Multiphase problems with sharp interface reconstruction and fluid–structure interaction are among the most promising applications. So far, a limitation of our scheme is the requirement of domain convexity and the inability to treat free surfaces. The benchmarks in this paper are two-dimensional, although we do not foresee major obstacles regarding the extension to three-dimensional problems. Further research could be directed toward improving the order of convergence, both in space (by means of a second-order reconstruction) and in time (using high-order IMEX schemes, such as CNAB integrator or implicit-explicit midpoint rule41). Compressible flows will also be addressed in the future, by solving a mildly nonlinear system for the pressure. For the sake of simplicity, we have used an explicit treatment of the viscous terms, but an implicit approach would be preferable for flows with very small Reynolds number, as presented in Reference 59.
ACKNOWLEDGMENTS
This work was financially supported by the Italian Ministry of University and Research (MUR) in the framework of the PRIN 2022 project number 2022N9BM3N. WB received financial support by Fondazione Cariplo and Fondazione CDP (Italy) under the project number 2022-1895. IP and WB are members of the INdAM GNCS group in Italy. Open access publishing facilitated by Universita degli Studi di Trento, as part of the Wiley - CRUI-CARE agreement.
APPENDIX A: PROOF OF THEOREM 1
We remind that is an open, bounded and convex polytope and the seeds are distinct. We wish to prove that for any :
(A1)
and that
(A2)
Proof.Let us show (A1) for and . Choosing an appropriate coordinate system, we can freely assume and
(A3)
where and . Let us define
(A4)
Then does not depend on and
(A5)
where
(A6)
Having this notation in place, we can perform a formal computation:
(A7)
And similarly:
(A8)
Needless to say, it is not a priori clear that all steps in this computation were legal. To begin with, the interchange of the integral and derivative sign () requires a further justification. So does the usage of Leibniz rule for a discontinuous integrand (). We shall address these concerns later. Now, we notice that
(A9)
parametrizes a plane (or line, if ). Let us call the plane . Then has a surface element
which is the sought result (A1). Equation (A2) can be easily deduced from (A1) by writing
(A12)
and differentiating both sides of the equation with respect to .
To justify the step , we would like to verify
(A13)
for all . Such claim is quite challenging to prove because it is not true. It only holds when is continuous at . Fortunately, it is enough to show (A13) for almost every . In other words, we need that is a null set with respect to the surface measure on . To see this, consider that is a subset of a finite union of planes, where each of them falls into one of two categories:
a plane that extends a facet of the polytope ,
a plane , which is the locus of points equidistant to and some other generating seed , where .
In the former case, is contained in the open half-space defined by the plane and the inward normal vector. Then, because is nonempty. (It is here and only here, where the convexity of is required.) In the latter case, we have since is a reflection of with respect to and . Since the planes which compose (a superset of) the boundary of are different from , their intersection is either empty or a linear space of lower dimension and hence, a null set in the measure.
To finalize the proof, we need to justify (). Using the dominated convergence theorem (see, e.g., Corol. 5.7 in Reference 61), it suffices to find an integrable function such that
(A14)
for almost every and every in some neighborhood. Let the neighborhood be
(A15)
where is a fixed positive number. Denoting the diameter of , we find
The algorithm presented in this paper is implemented in the code which is publicly available under the MIT license.60 All other data are available upon reasonable request to the corresponding author.
REFERENCES
1Winslow AM. “Equipotential” Zoning of Two-Dimensional Meshes. Technical Report. Lawrence Livermore Lab: California University. 1963.
5Boscheri W, Dumbser M. A direct arbitrary-Lagrangian–Eulerian ADER-WENO finite volume scheme on unstructured tetrahedral meshes for conservative and non-conservative hyperbolic systems in 3D. J Comput Phys. 2014; 275: 484-523.
11Fritts MJ, Crowley WP, Trease H. The Free-Lagrange Method: Proceedings of the First International Conference on Free-Lagrange Methods, Held at Hilton Head Island, South Carolina, March 4–6, 1985. Springer; 1985.
12Crowley W. FLAG: a free-Lagrange method for numerically simulating hydrodynamic flows in two dimensions. Proceedings of the Second International Conference on Numerical Methods in Fluid Dynamics: September 15–19, 1970 University of California, Berkeley. Springer; 2005: 37-43.
16Gaburro E, Boscheri W, Chiocchetti S, Klingenberg C, Springel V, Dumbser M. High order direct arbitrary-Lagrangian-Eulerian schemes on moving Voronoi meshes with topology changes. J Comput Phys. 2020; 407:109167.
22Kulasegaram S, Bonet J, Lok T, Rodriguez-Paz M. Corrected smooth particle hydrodynamics-a meshless method for computational mechanics. CD-Rom Proceedings of European Congress on Computational Methods in Applied Sciences and Engineering ECCOMAS-2000, Barcelona, 11-14 September. CIMNE; 2000.
25HE Trease, MF Fritts, WP Crowley, eds. Advances in the Free-Lagrange Method Including Contributions on Adaptive Gridding and the Smooth Particle Hydrodynamics Method. Lecture Notes in Physics. Vol 395. Springer Berlin Heidelberg; 1991.
27Howell B, Ball G. A free-Lagrange augmented Godunov method for the simulation of elastic–plastic solids. J Comput Phys. 2002; 175(1): 128-167. doi:10.1006/JCPH.2001.6931
30Osher S, Solomon F. A partially implicit method for large stiff systems of Ode's with only few equations introducing small time-constants. SIAM J Numer Anal. 1976; 13: 645-663.
32Dumbser M, Casulli V. A conservative, weakly nonlinear semi-implicit finite volume scheme for the compressible Navier-Stokes equations with general equation of state. Appl Math Comput. 2016; 272: 479-497.
33Boscheri W, Pareschi L. High order pressure-based semi-implicit IMEX schemes for the 3D Navier-stokes equations at all Mach numbers. J Comput Phys. 2021; 434:110206.
34Izzo G, Jackiewicz Z. Strong stability preserving IMEX methods for partitioned systems of differential equations. Commun Appl Math Comput. 2021; 3(4): 719-758.
40Boscheri W, Pisaturo G, Righetti M. High order divergence-free velocity reconstruction for free surface flows on unstructured Voronoi meshes. Int J Num Meth Fluids. 2019; 90: 296-321.
42Börgers C, Peskin CS. A Lagrangian method based on the Voronoi diagram for the incompressible Navier stokes equations on a periodic domain. The Free-Lagrange Method. Springer-Verlag; 1985: 87-113.
43Börgers C, Peskin CS. A Lagrangian fractional step method for the incompressible Navier-stokes equations on a periodic domain. J Comput Phys. 1987; 70(2): 397-438.
48Fabri A, Pion S. CGAL: the computational geometry algorithms library. Proceedings of the 17th ACM SIGSPATIAL International Conference on Advances in Geographic Information Systems. ACM; 2009: 538-539.
51Springel V. E pur si muove: Galilean-invariant cosmological hydrodynamical simulations on a moving mesh. Mon Notice R Astron Soc. 2010; 401(2): 791-851.
55Liska R, Wendroff B. Comparison of several difference schemes on 1D and 2D test problems for the Euler equations. SIAM J Sci Comput. 2003; 25(3): 995-1017.
56Ghia U, Ghia KN, Shin C. High-Re solutions for incompressible flow using the Navier-stokes equations and a multigrid method. J Comput Phys. 1982; 48(3): 387-411.
57Rayleigh. Investigation of the character of the equilibrium of an incompressible heavy fluid of variable density. Proce Lond Math Soc. 1882; 1(1): 170-177.
Please check your email for instructions on resetting your password.
If you do not receive an email within 10 minutes, your email address may not be registered,
and you may need to create a new Wiley Online Library account.
Request Username
Can't sign in? Forgot your username?
Enter your email address below and we will send you your username
If the address matches an existing account you will receive an email with instructions to retrieve your username
The full text of this article hosted at iucr.org is unavailable due to technical difficulties.