1. Introduction
Smoothed Particle Hydrodynamics (SPH) is a widely used mesh-free method for Computational Fluid Dynamics. The method was originally developed to simulate problems in astrophysics, but it is currently applied to many engineering fields [
1,
2,
3]. In recent years, SPH has gained many improvements in accuracy and efficiency increasing the attention of the scientific community. However, regardless of all the unquestionable advances, SPH has not attained a complete state of maturity yet, and it faces several challenges that require to be addressed by the scientific community [
4].
Similar to the Finite Volume Method [
5,
6], in SPH there are two main approaches to model liquids. One is based on the incompressibility assumption of the Navier–Stokes equations. This assumption leads to the decoupling of the equations and the continuity equation can be considered as a constraint the velocity field has to satisfy. The methods are based on the solution of a Poisson equation for the pressure field, using the pressure-correction idea from grid-based methods [
7,
8,
9]. This approach is known as Incompressible SPH (ISPH). The second approach, introduced by Monaghan [
10] is based on Weakly Compressible hypotheses (WCSPH). In this approach, the incompressibility is approximated by artificially allowing a slight flow compressibility. One advantage of this approach is that it avoids the need for solving a Poisson equation to compute the pressure field. The computation of pressure only requires the use of an equation of state (EOS). As the density of most liquids is nearly constant, a barotropic approximation is reasonable, and a linear EOS depending only on density is often used [
11]. Both approaches has advantages and drawbacks. Thus, one advantage of weakly-compressible methods, is that these schemes are more suited for free-surface flows as the boundary condition along the free surface is implicitly satisfied, and do not require an explicit detection of the free surface during the flow evolution. ISPH schemes are more difficult to parallelize because of the need for solving an algebraic system with a sparse matrix. However, the weakly-compressible approach requires small time steps (as it is constrained by the speed of sound), whereas ISPH allows for larger time steps. On the other hand, in weakly compressible approach, oscillations in density and pressure typically appear in the solution. In order to alleviate these oscillations, several authors have proposed two different procedures. The first one was introduced by Colagrossi et al. [
12], proposing a filtering of the density field. It reduces the numerical noise by restoring the consistency between mass, density and volume. The second procedure is more recent, and was introduced by Marrone et al. [
13]. They developed the
-SPH scheme, in which a density diffusive term is added to smooth the spurious density oscillations.
Some of the properties that need to be improved in SPH methods are convergence, consistency and stability. In this framework, the use of Riemann solvers is a promising option to increase the stability of the numerical methods. In particular, in this work we use the SPH-ALE method [
14,
15]. In this scheme, Riemann solvers are used instead of artificial dissipation to stabilize the method. The Riemann problem is solved between two neighboring particles on the direction of the line connecting them. Left and right Riemann states are defined using the values of the variables on each of the neighboring particles, and Taylor series expansions of the variables at integration points are used to improve the accuracy of the SPH scheme.
Differently from conventional SPH methods, which are purely Lagrangian schemes, the SPH-ALE is built using an Arbitrary Lagrangian–Eulerian (ALE) framework. In this method, introduced by Vila and Ben Moussa [
14,
15], it is possible to configure the scheme to work in both Lagrangian and Eulerian versions. This flexibility is a great advantage of the SPH-ALE method.
A well-known fact about high-order reconstructions is that they produce the so-called Gibbs phenomenon, that is, spurious numerical oscillations around sharp flow gradients or discontinuities. In order to mitigate this phenomenon and stabilize the numerical method, different procedures exist. If the stabilization procedure is performed at time
to prevent the occurrence at time
, the approach is labeled as
a priori. Among the
a priori approaches we can name limiting or stabilizing procedures used in SPH such as artificial viscosity [
16,
17], MUSCL with slope limiter [
18], or ENO/WENO [
19,
20]. These methods are applied to locally increase the numerical diffusion for eliminating the nonphysical oscillations. Moreover, under the SPH-ALE framework in [
11] is proposed a
-SPH-ALE scheme that smooths spurious oscillations without the complexity induced by the resolution of Riemann problems and the use of slope limiters. The other possibility is to apply the stabilization procedure once the troubled particles are identified. This is performed by computing the solution at time
and then identifying the particles where the computations have failed. This is called the
a posteriori approach. This methodology was introduced in [
21] and applied to the SPH-ALE method in [
22] for the resolution of the Euler equations.
The main objective of this work is to develop a mesh-less method able to solve slightly compressible fluids, circumventing some of the drawbacks of current weakly compressible formulations or incompressible SPH. In particular, our methodology does not require any special initialization of the particles, such as the particle packing algorithm [
12] in the
-SPH method, and the oscillations in density and pressure that are typical of weakly-compressible schemes are largely reduced in our scheme. Instead of adding an explicit diffusive term to the density equation, as in the
-SPH scheme, the dissipation required for stabilization is introduced by the Riemann solvers. Moreover, as the proposed method is an ALE method, it is an alternative to the recently developed Eulerian ISPH [
9]. We note that the results obtained in the selected test cases using the proposed methodology are comparable to the current standards in CFD. Thus, the proposed methodology is a competitive alternative to current state-of-art SPH methods for incompressible flows. In this work, we extend the method proposed in [
22] to weakly compressible viscous flows. The usual approach to extend the SPH-ALE methodology to viscous flows is to consider the SPH-ALE discretization of the Euler equations supplemented with an additional term that accounts for the viscous effects [
23,
24,
25]. Here, we propose a different approach based on the use of Moving Least Squares approximations (MLS). This approach does not increase the computational complexity of the scheme since the viscous terms are computed using the same reconstruction already calculated for the convective terms.
2. Governing Equations
Navier–Stokes equations are derived by imposing the physical principles of conservation of mass, momentum, and energy to a Newtonian fluid system. Adopting an ALE approach the system of equations can be expressed in a differential conservative form by
where
stands for the velocity of the Lagrangian frame and
is the vector of conservative variables. The operator
is called the transport operator linked to
. Its application over
is designated by
and results in
. We denote with
the non-viscous flux tensor (convective and pressure terms),
represents the viscous tensor and vector
contains the source terms.
For two-dimensional cases, the vectors and tensors previously introduced are given by
where the fluxes
and
are the rows of the flux tensor
, namely,
. Similarly, the viscous tensor is
.
The fluid velocity vector and its components in x and y directions are denoted by . Density and pressure are designed by and p. We use E for the specific total energy defined as the sum of the internal energy and the kinetic energy according to . Moreover, the total enthalpy is defined as .
For the diffusive terms, denotes the viscous tensor component and the thermal conduction flux component. For an incompressible Newtonian fluid, can be expressed as being the dynamic fluid viscosity. Similarly, the thermal flux could be expressed in terms of temperature gradients and thermal conductivity according to . Finally, in the source term vector (), and represent external force components per unit mass, whereas is a volumetric heat source.
In order to model a weakly-compressible flow, we consider two different equations of state (EOS): Tait and Tammann EOS.
Tait EOS models a barotropic fluid, and the pressure only depends on the density, that is,
. Tammann EOS is more general and relates pressure with both the density and the internal energy, that is,
. Tait EOS keeps the energy equation decoupled from the momentum equation and can lead to computational cost savings when energy effects on the flow are negligible. However, when shock waves are present in the flow, the Tammann EOS is a more convenient choice.
Table 1 shows the expressions to evaluate pressure and acoustic sound speed for any of the EOS adopted in this work. Caloric equations are also provided although its inclusion is optional for a barotropic fluid. The last row in the table presents the whole set of constants values required to properly set each EOS. These values are fixed case by case in the validation section. Zero subindex in Tait equation means the constant is associated to the reference state of the fluid.
3. SPH-ALE Formulation
The computational domain
is discretized by a set of
N particles at positions
. Index
i is used to label particles and ranges from 1 to
N. Each particle has an effective volume
. Besides the volume, particles have other properties that we refer with a generic variable
. Moreover, each particle
i has
neighboring particles inside its compact support domain
as schematically represented in
Figure 1.
The SPH-ALE formulation was introduced by Vila and Ben Moussa [
14,
15] to increase the accuracy and stability of SPH methods in nonlinear systems of conservation laws. Vila and Ben Moussa applied this formulation to the Euler equations and presented a system of equations in semidiscrete form that has many similarities with the finite volume formalism. Since then, several developments were made by incorporating consolidated techniques used in mesh based methods like approximate and partial Riemann solvers, MUSCL, MOOD, and WENO [
19,
22,
28].
In the SPH-ALE formulation, the interaction of each neighboring particle
j with the particle
i admits a representation as a flux at the midpoint
located at
. Fluxes are computed from solutions to one-dimensional moving Riemann problems. Thus, we can associate the particle
i as the left state, particle
j as the right state and the moving interface with the midpoint
.
Figure 2 shows the definition of one of the moving Riemann problems. Unit vector
points from particle
i to particle
j. We use index
and
to denote reconstruction values at the interface from the left and from the right. The kernel gradient can be expressed in terms of the unit vector
. Kernel functions which depend only on the distance between particles can be expressed as
, where
.
The gradient of the kernel function is given by showing that and are vectors with the same direction.
Several authors have proposed the SPH-ALE formulation for the Navier–Stokes equations [
23,
24,
25]. In these works, the viscous term was discretized using an approximation of the Laplacian based on a hybrid SPH gradient by means of a first-order finite difference scheme [
29]. In this work, we propose a different discretization for the viscous term of the Navier–Stokes equations. Observation of the Navier–Stokes in ALE form Equations (
1)–(
4) suggests that the viscous terms can be computed in the form of a diffusive flux, following a similar approach as the one used for the convective terms.
Thus, the proposed resulting semi-discretized form of the Navier–Stokes equations is given by
where Equation (
5) expresses the evolution of the conservative variables and Equation (
6) describes the evolution of the effective volume associated to particle
i. In the above equations,
is a kernel function and
is the smoothing length. The length
is linked to the particle volume via equation
, where
is a constant and
D is the dimension of the computational domain. Throughout this work, we have set
. Note that, as the interparticle distance
can be estimated as
, we adopt the practical consideration of linking the smoothing kernel length by a constant factor
to the interparticle distance
.
Moreover, we choose the cubic spline kernel proposed by Monaghan and Lattanzio [
30] as kernel function. The support radius for cubic spline kernel is given by
. This implies that, for an initial uniform distribution of particles,
, resulting in 9 neighbors for 1D tests and 49 neighbors for 2D problems.
Tensors
and
in Equation (
5) account for the Euler and viscous fluxes in the interface
, respectively. The terms appearing with minus sign inside the parenthesis (
and
) are tensors evaluated at the position of particle
i that assure at least zero order consistency at discrete level [
19].
3.1. Discretization of the Convective Terms
The numerical flux tensor
is computed using the Rusanov flux in the co-moving frame according to
where
and
denote the approximations of the Lagrangian flux tensor
on the left and right sides of the interface
.
The term
is the maximum eigenvalue of the Jacobian matrix which in the Arbitrarian Lagrangian–Eulerian (ALE) framework reads
where
is the jump of the reconstructed conservative variables. Moreover, the term
is the velocity of the reference frame at the interface
. On an Eulerian frame,
, whereas on a Lagrangian frame
.
We note that, despite the known diffusive behavior [
31] of the Rusanov flux, it can be easily used with different EOS, so it is a convenient choice for the problems addressed here.
Tensor is the Lagrangian flux computed as a function of the state of the i-th particle .
In the SPH-ALE formulation, each particle
i is associated with a velocity frame
and a material velocity
. The velocity frame
can be freely chosen and determines the evolution of particle positions. For the Eulerian approach of the method we set
and particles are fixed in space. For the Lagrangian version, we set
and perform a weighted average interpolation of the velocity [
32] to update particle positions. Therefore, the evolution of the particle position must satisfy for Eulerian/Lagrangian frame Equation (
7).
3.2. High-Order Reconstruction and Moving Least Squares Approximations
One way to increase the accuracy of the resulting scheme is to compute the reconstruction of the variables at each integration point
using a high-order approximation. For a given variable
, which is known on each particle, we can compute the reconstructed variable at integration point,
, by means of Taylor series as
where the first and successive derivatives are computed, following our previous work [
22], using MLS approximations.
3.3. Viscous Terms Discretization
In this work, we propose to extend the same discretization that is typically performed in the Finite Volume method to SPH-ALE discretizations. Tensor
is the viscous tensor computed as a function of the state of the
i-th particle and the gradients obtained at integration point
as
where the derivatives required to evaluate the viscous tensor are computed with MLS reconstruction. Note that since the MLS reconstruction is performed for the convective terms, it does not require any additional reconstruction procedure to obtain a highly accurate discretization of the fluxes.
4. The Multi-Dimensional Optimal Order Detection (MOOD) Method
The a posteriori MOOD paradigm, introduced by Clain et al. [
21], is used in this work to determine the optimal order of the polynomial reconstruction iteratively by building a candidate solution
for time
based on the
solution. The candidate solution is then run by a series of detectors that check if the solution has a certain set of desirable properties. If any of the particles is flagged as invalid, the candidate solution at that particle is discarded and recomputed from the original solution at
but using a more dissipative scheme by lowering the polynomial reconstruction degree.
4.1. Mood Loop
The MOOD approach is composed of a Particle Polynomial Degree (PPD) and a chain of detectors. The PPD refers to the actual polynomial degree used to compute the candidate solution . We evaluate the flux at the midpoint between particles i and j, taking the minimum of the respective PPDs for the polynomial reconstruction as . The chain of detectors controls the validity of the resulting solution and the particle’s PPD is decremented where any of the detectors flag the solution as invalid.
The MOOD loop iterates through the PPD map, initialized with maximal order , decreasing the order of the particles that present a non-physical or invalid solution. In this work only orders 3 and 1 are used, being the order 1 called the parachute scheme that, by definition, fulfills all the detectors requirements.
If the PPD map is modified, the candidate solution is declared not valid and therefore must be recomputed. Note that only the particles where the PPD map is modified are recomputed.
4.2. Chain Detectors
In order to obtain a stable solution within the SPH formulation, a chain of detectors is used to assess whether the solution is admissible or not. In this work, we employ two detectors:
where
is the set of closest particles and the tolerance
is defined following [
33] as
5. Numerical Tests
We present the numerical tests selected to assess the ability of the SPH-ALE-MOOD scheme to produce accurate and robust approximations. All the numerical examples have been computed using a third-order Runge–Kutta scheme for time integration.
5.1. 1d Riemann Problems
The first test cases are devoted to assess the stability and diffusive properties of the SPH-ALE-MOOD scheme. Here, we consider several one-dimensional tests.
The first test case is the 1D Riemann problem (R1) which is one of the four proposed by Marongiu in [
34]. In the context of SPH, the works presented in [
11,
18] also simulate this 1D Riemann problems with Tait EOS. The fluid is water modeled with Tait EOS (
kg/m
3,
m/s,
and
Pa). The domain is
m and the initial condition is defined as
A discretization of 100 particles is used and the solution is advanced up to
s. The exact solution consists of a rarefaction wave traveling to the left and a shock wave traveling to the right. As a reference solution, we use the exact solution obtained with the algorithm given in [
35] applied to the Tait EOS as indicated in [
36].
Figure 3 plots the pressure and velocity profiles obtained with the base scheme (first-order SPH-ALE scheme) [
15] and with the SPH-ALE-MOOD model. The SPH-ALE base scheme smears the solution in the shock and rarefaction wave. As expected, for the same number of particles the SPH-ALE-MOOD provides a better representation of the shock front. The front and tail of the rarefaction wave provided for the SPH-ALE-MOOD are also accurately captured and are free of overshoots near discontinuities. Both Eulerian and Lagrangian versions of the scheme produce very similar results, so we only plot here the results obtained with the Lagrangian description.
We consider a second one-dimensional Riemann problem (R2). In this case, the liquid is assumed to follow the Tamman EOS (
and
Pa). This test was proposed by Ivings and Toro in [
36] and has been also presented in [
37] with a SPH-ALE code with MUSCL reconstruction using a minmod limiter and a finer particle resolution. The initial conditions for this problem are
The exact solution to this problem comprises a left-going rarefaction wave, a contact discontinuity and a right-going shock wave. The computational domain is discretized with 200 particles.
In
Figure 4 we plot the results for pressure, velocity, density, and internal energy at the final time
s obtained with the SPH base scheme and the SPH-ALE-MOOD using a Lagrangian description. The SPH-ALE-MOOD improves the results of the SPH base scheme in all the salient features present in the flow. In the density and internal energy plots, it is observed that the resolution of the contact discontinuity is not as sharp as the one obtained for the shock front. We note that the smearing in the contact discontinuity is inherent to the approximations made in the derivation of the Rusanov flux as reported in previous works [
19,
22].
5.2. 2d Blast Explosion
The first two-dimensional test considered here is an extension of the one-dimensional shock tube R1 assuming cylindrical symmetry. The fluid is water modeled with Tait EOS (
,
,
and
). The computational domain is a circle of radius
centered at the origin and the initial conditions are given by
The configuration mimics an explosion with a shockwave traveling outwards and a rarefaction moving towards the origin. The reference solution is obtained by using a one dimensional finite volume code with a very fine mesh as explained in [
35].
The evolution of the flow is simulated until s with the SPH-ALE-MOOD scheme.
We consider three different particle initializations to evaluate the effects of the initial positions of the particles on the quality of the numerical results. A radial distribution disposing particles in rings, a Delaunay distribution, which places particles in barycenters of triangles and finally, the third initial layout of particles is the result of applying a random displacement to the Delaunay distribution. The number of particles of the radial distribution (∼90,000) is slightly higher than the one of the Delaunay and Random distribution (∼75,000).
Figure 5 shows the initial distributions considered.
Figure 6 shows the density at final time for the three initial particle layouts. The reference solution is represented with a black solid line. It is observed that the results preserve the radial symmetry of the physical problem.
Figure 7 plots the density profiles along the radial coordinate. All the particles of the computational domain are represented and it can be noticed more clearly the ability of the model to preserve the radial symmetry. We note that the dispersion of the particles is really small for all particle distributions.
5.3. Taylor–Green Flow
The Taylor–Green flow is a classical test for numerical methods for the simulation of viscous flows. It provides an exact solution of the incompressible Navier–Stokes equations in a periodic domain [
38,
39]. The flow involves the decay of four counter-rotating vortices within the periodic region of size
as shown in
Figure 8The exact solution is given in [
40] and reads
where
is the Reynolds number of the flow, defined as
.
is a reference velocity magnitude, and
and
are constant values for the density and viscosity of the fluid, respectively.
A global decay kinetic energy factor, denoted by
, is defined as the ratio of the overall kinetic energy at time
t (
) and the corresponding one to initial time
Evaluation of (
15) with the velocity field given by Equations (
12) and (
13) results in an exponential decay according to
and by integration in the domain results
.
For the simulations presented in this test, we consider a Taylor–Green flow with
m,
m/s and
1 kg/m
3. According to the weakly compressible approach, we assume that the fluid obeys the Tait equation with parameters
kg/m
3,
m/s,
and
Pa. The case is simulated for
,
and
with the Eulerian version of the SPH-ALE-MOOD scheme. Fluid particles are disposed inside the square domain on a Cartesian arrangement with
as shown in
Figure 9.
The initial conditions are computed using Equations (
12)–(
14) with the value of the density obtained from the Tait EOS for the analytical pressure.
Figure 10 shows the velocity components and pressure at non-dimensional time
. Velocity and pressure are smooth, similar to the analytical solution and no degradation of the vortical pattern is observed.
Figure 11 shows the time evolution of global decay of the kinetic energy,
, and the maximum velocity modulus obtained using the SPH-ALE-MOOD method and the corresponding reference incompressible solution for three different Reynolds numbers:
,
, and
. The numerical results are in close agreement with the analytical solution, showing that the high-order reconstruction of the proposed scheme allows achieving a low dissipation scheme which is accurate for a wide range of
numbers.
Following the work in [
41], we have measured the time evolution of the pressure at the center of the domain for
and
cases. The results are compared in
Figure 12 with the theoretical solution and the solutions obtained with the
-SPH and
-SPH presented by Sun et al. [
41,
42]. We note that the proposed scheme shows better agreement with the reference solution for all particle resolutions. Moreover, it is remarkable the reduced amount of pressure oscillations, even for coarse discretizations.
In
Figure 13, the pressure field along
is shown at
for
. The results closely follows the theoretical solution even for the coarser discretization.
Concerning the computational cost of the proposed scheme,
Figure 14 plots the CPU time consumed for different particle discretizations for a simulation until a final time of
for
. As expected, the Eulerian scheme is faster than the Lagrangian method. Then, a possible way for improving the efficiency of the proposed method is to combine Eulerian and Lagrangian particles. This idea has been explored previously in the context of ISPH [
43] and fits very naturally in the proposed formulation.
5.4. Couette and Poiseuille Flows
Couette and Poiseuille flows are special configurations of the incompressible Navier–Stokes equations that have analytical solution [
44]. In both cases, a Newtonian fluid moves between two infinite parallel plates. The Couette flow is driven by the movement of one of the plates whereas the Poiseuille flow is driven by a pressure gradient. As velocity does not vary along the flow direction, a finite length of the plates is considered with periodic boundary condition in left and right sides.
Figure 15 shows the geometry model and boundary conditions considered for the simulations. In both configurations the fluid is initially at rest.
In the Couette flow, the time-dependent exact solution for the fluid velocity in the
x-direction can be expressed as [
44,
45]
where
is the horizontal velocity of the upper plate and
is the kinematic viscosity of the fluid.
Similarly, for the Poiseuille flow the transient exact solution is given by [
44,
45]
where
denotes a force source term in the x-momentum equation and, as such, it must be included in the source term
of the system of equations defined in (
4). The force source term
and the steady peak velocity in the midplane of the channel
are related by expression
.
For both problems, the Reynolds number is defined as considering the distance between plates L and the maximum velocity as the reference length and velocity scales.
In this work, we conduct Couette and Poiseuille simulations for
. The same value was adopted in the works of Chiron [
23], Ferrand [
46], and Fourtakas [
47]. The fluid is modeled using the Tait equation with
,
,
, and
. The kinematic viscosity considered for the fluid is
. The distance between plates is set to
and half of this distance is considered for the periodic length in the flow direction.
In the Couette flow, is set to , which leads to . For the Poiseuille flow, we impose the force source term as to produce the same number.
Figure 16 shows the arrangement of the particles employed for both the Couette and Poiseuille tests. The number of fluid particles between walls and periodic zones is 40 and 20, respectively, resulting in a squared arrangement with distance between particles
.
In addition to the fluid particles, we need to incorporate ghost particles for implementing the periodic and wall boundary conditions. For the wall ghost particles we follow the technique used in [
13]. A schematic representation of this technique is shown on the right of
Figure 16. Dirichlet boundary conditions for velocity on the wall require that ghost particles update their velocity
following the vector equation.
where
is the velocity of the mirroring fluid particle and
is the velocity vector of the wall. In case of fixed walls
and for the top moving wall in Couette flow
.
As we already have commented, one of the main advantages of the SPH-ALE method is the ability to use either Eulerian or Lagrangian description, and both configurations are able to obtain accurate solutions for this test case.
Figure 17 shows the velocity profiles obtained with the SPH-ALE-MOOD scheme for Poiseuille flow at
for the Eulerian and Lagrangian description. The exact solution is computed using Equation (
18). For
s the flow is practically in the steady state condition and the obtained numerical solutions agree almost perfectly with the exact solution.
Figure 18 shows the velocity profiles obtained with the SPH-ALE-MOOD scheme for the Couette flow at
. The exact solution is computed using Equation (
17). At
, the velocity of the moving plate changes abruptly from rest to an horizontal velocity
forming a sharp discontinuity in the velocity field. A short time after that event, the obtained numerical results slightly deviates over the exact solution. This effect increases with the Reynolds number. For the last time instant, displayed for each Reynolds in
Figure 18, the flow has practically reached the steady state, and the velocity profile is linear. The obtained results in the steady state are in close agreement with the exact solution for all the Reynolds numbers computed in this test case.
In
Figure 18, the deviation from the reference solution observed in the first time instants of the simulations for
and
, are due to a lack of particles. For these Reynolds numbers, the spatial discretization is not able to capture the abrupt change in the velocity. To verify this, we plot in
Figure 19 the results obtained for
at
(left) and
at
(right) for different particle resolutions. It is seen that as the particle resolution increases the deviation is reduced, as expected.
5.5. 2d Lid-Driven Cavity Flow
The final test presented to assess the behavior of the proposed method is the 2D flow inside a square lid-driven cavity of length
L. A schematic setup of the geometry is shown in
Figure 20. The lateral and bottom walls are stationary, while the top wall moves horizontally to the right at speed
.
Different Reynolds numbers, namely,
,
, and
, are studied and results are compared to Ghia [
48]. As in the previous case, the velocity of the frame is set to zero adopting the Eulerian version of the SPH-ALE-MOOD scheme.
Figure 21 shows the layout and the type of particles. A Cartesian layout is adopted using a discretization of 100 particles on each side. Lid-driven cavity does not introduce any new type of boundary conditions, but the wall corners need to be taken into account to properly update ghost particle information, as schematically presented in
Figure 21 on the top right corner.
In order to set the velocity for the corner particle
, we use a similar technique to the one proposed by Szewc [
49]. Focusing on the top-right wall corner and considering the nearest four particles. We have one fluid particle with velocity
, a ghost particle attached to the moving wall with velocity
, a ghost particle attached to the fixed wall with velocity
, and a ghost particle in the corner with velocity
.
evolves with the governing equations, and that
and
are updated according to Equation (
19). In order to set the velocity for the corner ghost particle
we impose the velocity in the vertex of the corner as the average of the four particles.
Figure 22 shows the horizontal and vertical velocity profiles along the vertical and horizontal center line for
,
, and
. Simulations were run for a
s, clearly a time much longer than the one needed to reach the steady-state condition. Results are in good agreement with the reference solution [
48] for all the Reynolds number considered. Moreover, the obtained solutions are compared with the ones obtained by Lee et al. [
50]. We note that the two schemes use the same number of particles for
. For
, the ISPH scheme from [
50] uses a finer discretization (
particles).
The contours of the velocity magnitude superposed with the streamlines after 500 s are shown in
Figure 23. It is seen that the scheme is able to reproduce the primary and secondary vortices of the flow.