Next Article in Journal
Elastic Characterization of Transparent and Opaque Films, Multilayers and Acoustic Resonators by Surface Brillouin Scattering: A Review
Previous Article in Journal
A Distribution Power Electronic Transformer with MMC
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

A Semi-Explicit Multi-Step Method for Solving Incompressible Navier-Stokes Equations

1
Centre Internacional de Mètodes Numèrics en Enginyeria (CIMNE), Edifici C1 Campus Nord UPC C/ Gran Capità, S/N 08034 Barcelona, Spain
2
Department of Civil and Environmental Engineering, Universitat Politècnica de Catalunya (UPC), 08034 Barcelona, Spain
*
Author to whom correspondence should be addressed.
Appl. Sci. 2018, 8(1), 119; https://doi.org/10.3390/app8010119
Submission received: 19 December 2017 / Revised: 10 January 2018 / Accepted: 14 January 2018 / Published: 16 January 2018
(This article belongs to the Section Mechanical Engineering)

Abstract

:
The fractional step method is a technique that results in a computationally-efficient implementation of Navier–Stokes solvers. In the finite element-based models, it is often applied in conjunction with implicit time integration schemes. On the other hand, in the framework of finite difference and finite volume methods, the fractional step method had been successfully applied to obtain predictor-corrector semi-explicit methods. In the present work, we derive a scheme based on using the fractional step technique in conjunction with explicit multi-step time integration within the framework of Galerkin-type stabilized finite element methods. We show that under certain assumptions, a Runge–Kutta scheme equipped with the fractional step leads to an efficient semi-explicit method, where the pressure Poisson equation is solved only once per time step. Thus, the computational cost of the implicit step of the scheme is minimized. The numerical example solved validates the resulting scheme and provides the insights regarding its accuracy and computational efficiency.

1. Introduction

The solution of incompressible flow problems arising in real-life engineering applications calls for developing accurate, yet efficient schemes, as the associated computational time becomes a decisive factor for their use. Among the many methods available, one class of techniques commonly implemented is the well-known fractional step method.
The method was originally introduced in the works of Chorin [1] and Temam [2] for incompressible Navier–Stokes equations (independently, a similar methodology was developed and thoroughly studied by Yanenko [3,4]).
Basically, the method allows one to decouple the primary variables of the governing equations (the velocity and the pressure) and replaces the “monolithic” solution of the original coupled system by a series of solution steps, ensuring that only one variable (either the velocity or the pressure) is unknown at each step. First, the momentum equation is solved for an intermediate, non-solenoidal, velocity removing the dependence on the unknown pressure. Afterwards, the pressure is found, and the velocity is corrected fulfilling the incompressibility constraint.
It has been shown that the fractional step method can be viewed as a block LU decomposition of the original monolithic equations system [5]. The method is very popular due to the resulting computational efficiency (see, e.g., [6,7,8]). The accuracy of the method was addressed in [9]. Error estimates and pressure stability issues of the fractional step method have been analyzed in [10]. An exhaustive review of different implementation versions of the method can be found in [11]. A method that unifies the artificial compressibility approach and a fractional step method can be consulted in [12]. The fractional step methodology has been also applied to compressible flows modeling (see, e.g., [13,14]). The peculiarities of applying the fractional step method to multiphase flows with surface tension effects have been highlighted in [15].
While the majority of works on fractional step methods had been carried out considering fixed-grid (Eulerian) approaches, some recent works have analyzed the implications of applying the fractional step method to moving grid (Lagrangian) methods [16,17]. The fractional step method has been also applied for modeling incompressible solids [18].
In the context of incompressible flow modeling, the fractional step method is often applied in conjunction with implicit time integration schemes. This is the case for all the above-mentioned works. Purely explicit schemes cannot be applied to incompressible Navier–Stokes equations due to the implicit nature of the pressure.
On the other hand, an appealing possibility consists of developing a semi-explicit scheme, where velocity is integrated explicitly, while pressure is treated implicitly. A particularly appealing option relies on adopting an accurate high order methodology such as the Runge–Kutta time integration family. This has been followed in several works, e.g., [19,20,21,22,23,24,25,26].
In the context of finite volume methods, this was followed, e.g., in [21,22]. In [21], the accuracy of different versions of Runge–Kutta schemes is analyzed. The authors derive a predictor-corrector scheme, which is very similar to a fractional step one; however, no spitting error is committed as pressure is computed at every sub-step of the Runge–Kutta scheme. In [22], stability bounds of different fractional step-based schemes (including the ones using Runge–Kutta integration) are analyzed for high Reynolds number flows.
Several authors developed semi-explicit Runge–Kutta-based methods in the context of the finite difference framework. In [22], a third-order Runge–Kutta scheme for the convective term combined with a Crank–Nicholson integration for the viscous term was proposed. In [23], a fourth-order Runge–Kutta scheme equipped with the solution of the pressure Poisson equation at each sub-step is proposed (similar to [21]). The above-mentioned semi-explicit finite volume and finite differences approaches rely on solving the pressure Poisson equation at every sub-step of the multi-step scheme, which is a computationally-intensive option. The idea of reducing the number of implicit steps of a semi-explicit scheme has been proposed in [25]. In the finite difference context, the authors proposed a semi-explicit third-order Runge–Kutta-based scheme where the convective term was advanced explicitly, while treating the viscous term implicitly. Most importantly, they suggested assuming that the pressure corresponding to the intermediate Runge–Kutta steps equals the historical one. Thus, the computationally-expensive pressure Poisson equation was solved only once per time step.
In the present work, we develop a similar approach in the context of Galerkin finite element methods. In this work, we derive a scheme based on the combination of the fractional step technique with the fourth-order Runge–Kutta scheme, striving to minimize the computational cost corresponding to the implicit steps. We show that a certain assumption regarding the intermediate step pressures results in an efficient semi-explicit scheme that requires solving the pressure Poisson equation only once per time step.
The paper is organized as follows. We first define the space-discrete problem considering linear velocity-pressure stabilized finite elements. Afterwards, time-discrete equations using the fourth-order Runge–Kutta scheme are derived. Next, assumptions for the pressure at intermediate Runge–Kutta steps are introduced, and the fractional split is applied. The resulting semi-explicit scheme is obtained. The paper concludes with a numerical verification example. Time accuracy and computational efficiency of the method are estimated.

2. Governing Equations

The Navier–Stokes equations for incompressible flow defined over domain Ω with boundary Γ can be written as:
ρ u t + ρ ( u · ) u ρ ν Δ u + p = f ,
· u = 0 ,
where u is the velocity vector, p the pressure, t time, f the body force, ρ the density and ν the kinematic viscosity.
For ensuring the well-posedness of the system defined by Equations (1) and (2), suitable boundary conditions must be specified. On the boundary Γ = Γ D Γ N , such that Γ D Γ N = , the following conditions are prescribed:
u = u p r at Γ D ,
σ · n = σ n p r at Γ N ,
where u p r is the prescribed velocity, n is the outer unit normal to Γ N and σ n p r is the prescribed traction vector. Homogeneous boundary conditions will be considered here for the sake of simplicity.
We define symbolically the differential Navier–Stokes operator as:
A ( u , p ) = A 1 ( u , p ) A 2 ( u , p ) ,
where:
A 1 = ρ ( u · ) u ρ ν Δ u + p ,
A 2 = · u .
Then, introducing the notation F = f 0 , the governing equations can be written as:
ρ u t 0 + A ( u , p ) = F .

2.1. Space Discretization

The Galerkin weak form of (8) reads:
ω , ρ u t + ( ω , A 1 ) + ( q , A 2 ) = ω , f ,
where ω and q are the velocity and pressure test functions. In the notation adopted, ( · , · ) and · , · stand for a bilinear and linear forms, respectively.
In order to obtain stable solutions for convection-dominated flows, the equations must be stabilized. Additionally, pressure stabilization is necessary for equal order velocity-pressure interpolations, as they do not satisfy the compatibility condition [27]. The Galerkin/least squares (GLS) stabilization method allows one to circumvent this problem by summing n Ω A ( ω , q ) · ( F A ( u , p ) u t ) to the original weak form of the problem [28]. This means summing the product of the residual with the Navier–Stokes operator A ( ω , q ) (this operator may be viewed as a changed weight function). We note that for linear velocity-pressure elements, the GLS method coincides with the more recent (and less diffusive for a general case) algebraic sub-grid scale (ASGS) method [29], the latter being defined based on the adjoint operator A * as a weight function for the residual.
Summing up the Galerkin weak form with the stabilization terms results in:
ρ ( ω , u t ) + ρ ( ω , u · u ) + ( ω , p ) ρ ν ( ω , Δ u ) + ( q , · u ) + e l τ Ω e l q + ρ ω · ω ρ ν Δ ω ( f ρ u t ρ u · u + ρ ν Δ u p ) ,
where the stabilization coefficient τ is defined as (see, e.g., [28]):
τ = 2 | | u | | h + 4 ν h 2 ,
where h is the element size.
Integrating the viscous term by parts and rearranging the terms (noting that in Equation (10), products containing the test function ω contribute to the momentum equation, while the ones containing q contribute to the mass conservation equation), the modified linear momentum and mass conservation equations are obtained:
ρ ( ω , u t ) + ρ ( ω , u · u ) + ρ ν ( ω , u ) ( · ω , p ) + e l τ Ω e l ω · ω f ρ u t ρ u · u p = f , ω ,
( q , · u ) + e l τ Ω e l q f ρ u t ρ u · u p = 0 .
Prior to establishing the space-discretized stabilized governing system, we define the matrices and vectors corresponding to each term of Galerkin weak form:
( ω , u ) M u ¯ ,
( · ω , p ) G p ¯ ,
( ω , u ) L u ¯ ,
ω , u · u C ( u ¯ ) u ¯ ,
f , ω F .
The operators corresponding to the stabilization terms are:
e l τ Ω e l ( ω · ω ) ( ω · u ) S 1 u ¯ ,
e l τ Ω e l ( ω · ω ) ( u ) S 2 u ¯ ,
e l τ Ω e l ( ω · ω ) ( p ) S 3 p ¯ ,
e l τ Ω e l ( ω · ω ) ( u t ) M s t u ¯ t ,
e l τ Ω e l ( ω · ω ) ( f ) F s 1 ,
e l τ Ω e l ( q ) ( f ) F s 2 ,
e l τ Ω e l ( q ) ( u ) S 4 u ¯ ,
e l τ Ω e l ( q ) ( ( ω · ) u ) S 5 u ¯ ,
e l τ Ω e l ( q ) ( p ) L τ p ¯ .
Note that the variables distinguished by an over-bar ( u ¯ and p ¯ ) stand for vectors of nodal quantities.
Stabilized space-discrete equations in matrix form read:
M + M s t u ¯ t + ( μ L + C ( u ¯ ) + S 1 + S 2 ) u ¯ ( G + S 3 ) p ¯ = F + F s 1 ,
( D + S 4 + S 5 ) u ¯ + L τ p ¯ = F s 2 .
Note that dynamic viscosity μ = ρ ν was used. In the scope of applying the time integration scheme of an explicit type, the lumped form of the mass matrix is adopted.
For the sake of clarity, we shall introduce the following short-hand notation:
C ¯ = C + μ L + S 1 + S 2 ,
G ¯ = S 3 + G ,
F ¯ = F + F s 1 + M s t a ¯ n ,
D ¯ = D + S 4 + S 5 ,
F ^ = F s 2 ,
M ¯ = M + M s t .
Using this notation, the governing equations discretized in space read:
M ¯ u ¯ t + C ¯ u ¯ G ¯ p ¯ = F ¯ ,
D ¯ u ¯ + L τ p ¯ = F ^ .
Next, time integration must be performed.

2.2. Time Integration

Taking into account the implicit nature of the pressure in the incompressible flows, a fully-explicit time integration scheme cannot be used (strictly speaking, a fully-explicit scheme can be defined, but the associated critical time step would be prohibitively small, being governed by the acoustic pressure scale). However, one attractive option is defined by integrating the momentum equation explicitly, except for the pressure term, which is treated in an implicit way. Explicit time integration techniques are generally faster than their implicit counterparts as they do not involve non-linear iterations, nor require solving linear systems (in case mass matrix lumping is used). However, they are conditionally stable and are restricted by a critical time step size, which may be prohibitively small. A powerful commonly-used class of explicit methods is the family of Runge–Kutta time integration schemes. These integration methods involve the evaluation of residuals of the governing equation at several sub-steps. Runge–Kutta schemes with n intermediate steps are characterized by the n-th order of accuracy for n 4.
For larger values of sub-steps, the accuracy order is less than n. This makes the four-step scheme the most commonly-implemented version. Moreover, considering the restrictions of the critical time step size, this version of the method offers a good balance between the sub-step number and the maximum permissible time step size. The details regarding the stability domain of Runge–Kutta schemes can be consulted in, e.g., [28] (Chapter 5.3).
Considering that the solution of a given problem is known at t n , the Runge–Kutta method requires successive computation of the governing equation residuals at several sub-steps in order to obtain the solution at t n + 1 . For a general Cauchy problem of type:
y t = f ( y ( t ) , t ) ,
the Runge–Kutta scheme of fourth order provides:
y n + 1 y n Δ t = 1 6 [ k 1 + 2 k 2 + 2 k 3 + k 4 ] ,
where k 1 , , k 4 are the intermediate residuals or “right-hand side“ corrections that are obtained as:
k 1 = f ( t n , y n )
k 2 = f ( t n + Δ t 2 , y n + Δ t 2 k 1 ) ,
k 3 = f ( t n + Δ t 2 , y n + Δ t 2 k 2 ) ,
k 4 = f ( t n + Δ t , y n + Δ t k 3 ) .
Clearly, to compute y n + 1 , the function must be evaluated four times, at each intermediate step. It also involves four updates of the primary variable.
Next, the momentum equation is integrated using this scheme. The corresponding residual can be defined as:
r = F ¯ C ¯ u ¯ + G ¯ p ¯ .
Thus, the set of velocities and residuals to be computed in order to integrate the momentum equation in time using Equations (40)–(43) reads (note that the pressure terms are treated implicitly, i.e., they correspond to the end-of-sub-step values):
r 1 = F ¯ n C ¯ ( u ¯ n ) ( u ¯ n ) + G ¯ p ¯ α 1 ,
u ¯ α 1 = u ¯ n + 1 2 M ¯ 1 Δ t r 1 ,
r 2 = F ¯ α 1 C ¯ ( u ¯ α 1 ) ( u ¯ α 1 ) + G ¯ p ¯ α 2 ,
u ¯ α 2 = u ¯ n + 1 2 M ¯ 1 Δ t r 2 ,
r 3 = F ¯ α 2 C ¯ ( u ¯ α 2 ) ( u ¯ α 2 ) + G ¯ p ¯ α 3 ,
u ¯ α 3 = u ¯ n + M ¯ 1 Δ t r 3 ,
r 4 = F ¯ n + 1 C ¯ ( u ¯ α 3 ) ( u ¯ α 3 ) + G ¯ p ¯ α 4 .
Computation of the right-hand-side corrections r 1 , , r 4 exactly requires solving the mass balance equation at all the sub-steps. However, this would imply performing the implicit step four times, making the method computationally expensive.
In order to avoid this, we propose to assume that the pressure at the intermediate steps can be computed from a linear interpolation of the values at t n and t n + 1 . This leads to the following approximation:
  • p ¯ α 1 = p ¯ ( t n ) = p ¯ n ,
  • p ¯ α 2 = p ¯ ( t n + Δ t 2 ) = 1 2 ( p ¯ n + p ¯ n + 1 ) ,
  • p ¯ α 3 = p ¯ ( t n + Δ t 2 ) = 1 2 ( p ¯ n + p ¯ n + 1 ) ,
  • p ¯ α 4 = p ¯ ( t n + 1 ) = p ¯ n + 1 .
Following (39), the equation of linear momentum conservation in the discrete form can written as:
M ¯ u ¯ n + 1 u ¯ n Δ t = 1 6 [ r 1 + 2 r 2 + 2 r 3 + r 4 ] .
The assumption of the linear variation of pressure between t n and t n + 1 permits removing the gradients of pressure from the definition of the residuals and putting them into the overall momentum equation (this form will facilitate applying the fractional split that will be done next):
M ¯ u ¯ n + 1 u ¯ n Δ t = 1 6 [ r ¯ 1 + 2 r ¯ 2 + 2 r ¯ 3 + r ¯ 4 ] + 1 2 G ¯ p ¯ n + 1 + p ¯ n .
with the modified residuals (indicated by an over-bar) defined as:
r ¯ 1 = F ¯ n C ¯ ( u ¯ n ) ( u ¯ n ) ,
r ¯ 2 = F ¯ α 1 C ¯ ( u ¯ α 1 ) ( u ¯ α 1 ) ,
r ¯ 3 = F ¯ α 2 C ¯ ( u ¯ α 2 ) ( u ¯ α 2 ) ,
r ¯ 4 = F ¯ n + 1 C ¯ ( u ¯ α 3 ) ( u ¯ α 3 ) ,
considering that r = r ¯ + G p ¯ .
For the sake of brevity, we shall use the following notation for the sum of residuals:
R ¯ = 1 6 [ r ¯ 1 + 2 r ¯ 2 + 2 r ¯ 3 + r ¯ 4 ]

2.3. Fractional Step Split

The governing system consists of momentum Equation (53) and the mass conservation equation (Equation (37)), which in the time-integrated form is written as:
D ¯ u ¯ n + 1 + L τ p ¯ n + 1 = F ^ .
For decoupling the velocity from the pressure, we shall apply the fractional step split by introducing auxiliary velocity u ˜ , which is non-solenoidal.
The fractional split applied to Equation (53) leads to:
M u ˜ u ¯ n Δ t = R ˜ + γ G ¯ p ¯ n ,
M u ¯ n + 1 u ˜ Δ t = 1 2 G ¯ p ¯ n + 1 + 1 2 G ¯ p ¯ n γ G ¯ p ¯ n .
where γ = 0 (no pressure gradient in the fractional momentum equations) or γ = 1 (historical pressure gradient in the fractional momentum equation). The residuals are defined as:
R ˜ = 1 6 [ r ˜ 1 + 2 r ˜ 2 + 2 r ˜ 3 + r ˜ 4 ] ,
r ˜ 1 = F ¯ n C ¯ ( u ¯ n ) ( u ¯ n ) ,
r ˜ 2 = F ¯ α 1 C ¯ ( u ˜ α 1 ) ( u ˜ α 1 ) ,
r ˜ 3 = F ¯ α 2 C ¯ ( u ˜ α 2 ) ( u ˜ α 2 ) ,
r ˜ 4 = F ¯ n + 1 C ¯ ( u ˜ α 3 ) ( u ˜ α 3 ) .
We emphasize that after applying the fractional step split, the residuals of the fractional momentum equations correspond to the fractional velocities u ˜ . This is reflected by a “tilde” above the residual symbol ( R ˜ and r ˜ ). Note that summing Equations (60) and (61), one recovers the original momentum equation under the fractional step approximation, which consists of assuming that the generalized convective operator can be computed using the fractional velocity C ¯ ( u ¯ n + 1 ) C ¯ ( u ˜ ) . This means that convection is computed using the auxiliary non-solenoidal velocity. Following the ideas of [10], the resulting accuracy can be estimated. The corresponding splitting error depends on γ : O ( | | u ¯ n + 1 u ˜ | | ) = Δ t O ( | | 0.5 ( p n + 1 + p n ) γ p n | | ) . If γ = 0 , the order of approximation is Δ t . If γ = 1 , the order is Δ t 2 since O ( | | p n + 1 γ p n | | ) = Δ t . For higher accuracy, a second option is used here, thus choosing γ = 1 .
Applying the mass conservation Equation (59) to Equation (61) leads to:
Δ t D M 1 1 2 G p ¯ n + 1 1 2 G p ¯ n = D ¯ u ¯ F ^ L τ p ¯ n + 1 .
Introducing the commonly-used approximation of the Laplace operator D M 1 G L , one obtains:
M u ˜ u ¯ n Δ t = R ˜ + G ¯ p ¯ n ,
Δ t 2 L ( p ¯ n + 1 p ¯ n ) = D ¯ u ¯ F ^ L τ p ¯ n + 1 ,
M u ¯ n + 1 u ˜ Δ t 1 2 G ¯ ( p ¯ n + 1 p ¯ n ) = 0 .
which defines our discrete model. Equation (69) is known as the “pressure Poisson equation”. The problem is thus solved in three steps:
  • Fractional momentum (Equation (68)) is solved. Fractional velocity u ˜ is obtained (explicit step).
  • The equation for the pressure (Equation (69)) is solved. Pressure p ¯ n + 1 is obtained (implicit step).
  • Velocity is corrected (Equation (70)) giving u ¯ n + 1 (explicit step).
The accuracy and efficiency of the method proposed here will be estimated by means of a numerical test.

3. Numerical Example

The method was implemented within Kratos Multi-Physics, a C++ object-oriented FE framework [30]. For the solution of the linear equations system, the biconjugate gradient stabilized method (BICGSTAB) was used.

3.1. Accuracy of the Scheme

In this benchmark, the time accuracy and computational efficiency of the present model are tested. This benchmark was originally proposed in [10], where it was used for comparing the accuracy and stability of different fractional step methods. In this example, one solves Navier–Stokes equations in a unit square domain with homogeneous velocity conditions. A force vector is prescribed that corresponds to the following analytic solution:
u x ( x , y , t ) = f ( x ) f ( y ) g ( t ) , u y ( x , y , t ) = f ( x ) f ( y ) g ( t ) .
where f and g are:
f ( x ) = 100 x 2 ( 1 x ) 2 , g ( t ) = c o s ( 4 π t ) e t .
Two pressure solutions satisfy the problem: p = 0 and p = 100 x 2 . We adopt the second one as the initial condition for the pressure.
The physical properties of the fluid are as follows: kinematic viscosity is 0.001 m 2 /s, and the density is 1 kg/m 3 . The time interval considered was 1 s. A structured mesh of 80 × 80 linear triangular elements was used if not mentioned otherwise. Different time step sizes were tested. The method proposed here was compared with an implicit method obtained by applying the fractional step to equations obtained using the second order backward differentiation formula (BDF2) time integration scheme (the implicit implementation was validated in [31]). Since the method proposed here is a priori expected to exhibit second order convergence, the second order implicit scheme is selected for comparison. We note that not only the rate of convergence is of importance, but also the error itself (i.e., the ordinate position of the error vs. step size curve).
The velocity field at t = 1.0 is shown in Figure 1. The evolution of the horizontal velocity component U x at the point (x, y) = (0.75, 0.75) obtained using the implicit and the present semi-explicit scheme is shown in Figure 2 and Figure 3, respectively. One can see that as the time step diminishes, both the proposed method and the fractional step method tend to the exact solution. However, for the large time step, the implicit scheme clearly exhibits large error, while the semi-explicit Runge–Kutta scheme results in a solution nearly coinciding with the analytic one.
For assessing the accuracy quantitatively, the convergence of the time approximation is displayed in Figure 4. In order to obtain the graphs, the test was performed using various time step sizes in the range between Δ t = 0.05 s and Δ t = 0.001 s. Error versus time step size was plotted for the proposed semi-explicit and for the implicit method. The logarithmic scale was used. The error was computed as the sum of the nodal errors at time t = 1 s: E r r = n | u F E u e x a c t | | u e x a c t | (n is the number of nodes).
One can see that both schemes exhibit quadratic convergence. However, the error introduced by the proposed method is considerably smaller than that of the implicit method for a given time step. For example, the semi-explicit Runge–Kutta scheme with Δ t = 0.01 leads to the same error as the implicit scheme with Δ t = 0.001. This indicates that provided s lower computational cost (per time step) of the semi-explicit scheme, a considerable gain in the overall computational time is expected.

3.2. Computational Efficiency of the Scheme

In order to highlight the computational efficiency properties of the proposed method, the test described in the previous sub-section was performed using two time step sizes ( Δ t = 0.01 s and Δ t = 0.001 s) and two meshes (rough mesh: 6500 nodes and fine mesh: 160,000 nodes). The computational cost of different solution steps was estimated.
The test was performed on an Intel i5 desktop computer. It was executed on a single thread in order to gain the insight of the efficiency of the scheme without considering the gains obtained by parallel implementation. Poisson’s equation was solved using the biconjugate gradient stabilized algorithm with a diagonal preconditioning and a fixed tolerance of 10 3 .
The computational times corresponding to the solution of the fractional momentum equation (first step) and the pressure Poisson equation are displayed. The computational cost of the momentum equation correction is not displayed, being negligible. Computational times were calculated as the average over all time steps.
Figure 5 shows the computational times corresponding to the tests performed on the rough mesh. One can see that the costs of the solution of Poisson’s equation using both the proposed and the implicit schemes are nearly identical (around 0.02 s) for all considered time step sizes. The computational cost of the momentum equation solution equals 0.015 s in the case of the semi-explicit scheme and 0.035 s in the case of the implicit scheme for Δ t = 0.001 s. Increasing the time step to 0.01 s, the computational cost of the first step nearly does not change for the semi-explicit scheme, while it increases to 0.075 s in the case of the implicit scheme. This occurs due to the increased number of non-linear iterations necessary for the convergence of the implicit scheme.
Figure 6 shows the computational times obtained in the simulation carried out on a fine mesh. Similar to the results shown in the previous figure, the time required for the solution of Poisson’s equation is similar in both methods, while there is a considerable difference in the time required for the solution of the fractional momentum equation (first step). One can see again that for larger time steps, several non-linear iterations are required in the case of the implicit scheme. In the considered case, for Δ t = 0.01 s, the overall computational cost of the implicit method is more than three-times larger than that of the semi-explicit scheme (the cost of the first step is more than five-times higher in the case of using the implicit scheme). We also note that Figure 4 indicates that for achieving a given accuracy, the semi-explicit scheme allows using much larger time steps. For instance, a relative error of approximately 10 4 requires using Δ t < 0.001 s in the case of the implicit scheme, while the semi-explicit scheme leads to this accuracy already for Δ t = 0.01 s. Thus, the overall computational cost corresponding to the time accuracy is much smaller in the case of using the semi-explicit scheme.
We note that the one can estimate the restrictions of the semi-explicit scheme for a given problem knowing Courant and Fourier numbers. The latter strongly restricts the time step in the case of high viscosities. However, such engineering fluids as air or water are characterized by low viscosity. Thus, the present methodology can be successfully used for a wide range of practical applications.

4. Summary and Conclusions

This paper has shown how an efficient semi-explicit strategy can be derived in the framework of the stabilized Galerkin finite element methods. A methodology based on a combination of the Runge–Kutta time integration scheme with the fractional step technique was presented. It was shown that introducing an approximation for the pressure at the intermediate steps of the Runge–Kutta method leads to a scheme where the implicit step necessary for computing the pressure is performed only once.
A priori estimates, as well as numerical tests have shown that the time accuracy of the resulting scheme reduces to the second order; however, the value of the error for a given time step is several orders of magnitude smaller than the one arising when applying fractional step to second-order implicit schemes. Thus, for the problems where critical time step estimates due to CFL (Courant-Friedrichs-Lewy) criteria are favorable, the method proposed here defines a very advantageous option in comparison with the implicit schemes.
The overall computational cost of the resulting method is governed by the cost of a single solution of the pressure Poisson equation, which is an equation of inhomogeneous Laplace type. Thus, an important step to make the proposed method even more efficient is to devise a scheme for minimizing the cost of solving Poisson’s equation, which can be done at the level of the linear solver following algebraic multi-grid or deflation techniques [32].
Another observation is that even though implicit time integration schemes are preferred in the literature against explicit ones, the latter are in a better position attending to the present hardware technology. This is oriented toward the usage of parallel computers and general purpose graphic processor units (GPGPU) [33]. Thus, the cost associated with the first part may be considerable reduced.

Acknowledgments

This work was supported under the auspices of the COMETADproject of the National RTDPlan (Ref. MAT2014-60435-C2-1-R) by the Ministerio de Economía y Competitividad of Spain.

Author Contributions

The methodology has been developed by both authors. P. Ryzhakov implemented the multi-step method. J. Marti implemented the pressure correction. The accuracy analysis has been done by J. Marti, while computational efficiency estimation has been done by P. Ryzhakov.

Conflicts of Interest

The authors declare no conflict of interest.

References

  1. Chorin, A. A numerical method for solving incompressible viscous problems. J. Comput. Phys. 1967, 2, 12–26. [Google Scholar] [CrossRef]
  2. Temam, R.M. Sur l’approximation de la solution des equations de Navier-Stokes par la methode des pase fractionaires. Arch. Ration. Mech. Anal. 1969, 32, 135–153. [Google Scholar] [CrossRef]
  3. Yanenko, N. The method of fractional steps for solving multidimensional problems of mathematical physics. Novosib. Sci. 1967, 196. [Google Scholar]
  4. Yanenko, N. The Method of Fractional Steps. The Solution of Problems of Mathematical Physics in Several Variables; Translated from Russian by Cheron, T.; Springer: Berlin/Heidelberg, Germany, 1971. [Google Scholar]
  5. Blair Perot, J. An analysis of the fractional step method. J. Comput. Phys. 1993, 108, 51–58. [Google Scholar] [CrossRef]
  6. Kim, J.; Moin, P. Application of a fractional-step method to incompressible Navier-Stokes equations. J. Comput. Phys. 1985, 59, 308–323. [Google Scholar] [CrossRef]
  7. Donea, J.; Giuliani, S.; Laval, H.; Quartapelle, L. Finite element solution of the unsteady Navier-Stokes equations by a fractional step method. Comput. Methods Appl. Mech. Eng. 1982, 30, 53–73. [Google Scholar] [CrossRef]
  8. Turek, S. A Comparative Study of Some Time-Stepping Techniques for the Incompressible Navier-Stokes Equations: From Fully Implicit Nonlinear Schemes to Semi-Implicit Projection Methods; IWR: Wroclaw, Poland, 1995. [Google Scholar]
  9. Strikwerda, J.; Lee, Y. The accuracy of the fractional step method. SIAM J. Numer. Anal. 1999, 37, 37–47. [Google Scholar] [CrossRef]
  10. Codina, R. Pressure stability in fractional step finite element method for incompressible flows. J. Comput. Phys. 2001, 170, 112–140. [Google Scholar] [CrossRef]
  11. Guermond, J.; Minev, P.; Shen, J. An Overview of Projection methods for incompressible flows. Comput. Methods Appl. Mech. Eng. 2006, 195, 6011–6045. [Google Scholar] [CrossRef]
  12. Könözsy, L.; Drikakis, D. A unified fractional-step, artificial compressibility and pressure-projection formulation for solving the incompressible Navier–Stokes equations. Commun. Computat. Phys. 2014, 16, 1135–1180. [Google Scholar]
  13. Codina, R.; Vázquez, M.; Zienkiewizc, O. A general algorithm for compressible and incompressible flows. Int. J. Numer. Methods Fluids 1998, 27, 13–32. [Google Scholar] [CrossRef]
  14. Ryzhakov, P.; Rossi, R.; Oñate, E. An algorithm for the simulation of thermally coupled low speed flow problems. Int. J. Numer. Methods Fluids 2012, 70, 1–19. [Google Scholar] [CrossRef]
  15. Ryzhakov, P.B.; Jarauta, A. An embedded approach for immiscible multi-fluid problems. Int. J. Numer. Methods Fluids 2016, 81, 357–376. [Google Scholar] [CrossRef]
  16. Ryzhakov, P.; Oñate, E.; Rossi, R.; Idelsohn, S.R. Improving mass conservation in simulation of incompressible flows. Int. J. Numer. Methods Eng. 2012, 90/12, 1435–1451. [Google Scholar] [CrossRef]
  17. Ryzhakov, P. A modified fractional step method for fluid—Structure interaction problems. Rev. Int. Métodos Numér. Cálc. Diseño Ing. 2017, 33, 58–64. [Google Scholar] [CrossRef]
  18. Nithiarasu, P. A matrix free fractional step method for static and dynamic incompressible solid mechanics. Int. J. Numer. Methods Eng. Sci. Mech. 2006, 7, 369–380. [Google Scholar] [CrossRef]
  19. Nikitin, N. Third-order-accurate semi-implicit Runge–Kutta scheme for incompressible Navier-Stokes equations. Int. J. Numer. Methods Fluids 2006, 51, 221–233. [Google Scholar] [CrossRef]
  20. Ascher, U.; Ruuth, S.; Spiteri, R. Implicit-explicit Runge-Kutta methods for time-dependent partial differential equations. Appl. Numer. Math. 1997, 25, 151–167. [Google Scholar] [CrossRef]
  21. Sanderse, B.; Koren, B. Accuracy analysis of explicit Runge–Kutta methods applied to the incompressible Navier–Stokes equations. J. Comput. Phys. 2012, 231, 3041–3063. [Google Scholar] [CrossRef]
  22. Fishpool, G.; Leschziner, M. Stability bounds for explicit fractional-step schemes for the Navier–Stokes equations at high Reynolds number. Comput. Fluids 2009, 38, 1289–1298. [Google Scholar] [CrossRef]
  23. Kampanis, N.A.; Ekaterinaris, J.A. A staggered grid, high-order accurate method for the incompressible Navier–Stokes equations. J. Comput. Phys. 2006, 215, 589–613. [Google Scholar] [CrossRef]
  24. Ha, S.; Park, J.; You, D. A GPU-accelerated semi-implicit fractional-step method for numerical solutions of incompressible Navier–Stokes equations. J. Comput. Phys. 2018, 352, 246–264. [Google Scholar] [CrossRef]
  25. Le, H.; Moin, P. An improvement of fractional step methods for the incompressible Navier–Stokes equations. J. Comput. Phys. 1991, 92, 369–379. [Google Scholar] [CrossRef]
  26. Pareschi, L.; Russo, G. Implicit-explicit Runge–Kutta schemes for stiff systems of differential equations. Recent Trends Numer. Anal. 2000, 3, 269–289. [Google Scholar]
  27. Bathe, K.J. The inf–sup condition and its evaluation for mixed finite element methods. Comput. Struct. 2001, 79, 243–252. [Google Scholar] [CrossRef]
  28. Donea, J.; Huerta, A. Finite Element Method for Flow Problems; Wiley: New York, NY, USA, 2003. [Google Scholar]
  29. Codina, R. A stabilized finite element method for generalized stationary incompressible flows. Comput. Methods Appl. Mech. Eng. 2001, 190, 2681–2706. [Google Scholar] [CrossRef]
  30. Dadvand, P.; Rossi, R.; Oñate, E. An object-oriented environment for developing finite element codes for multi-disciplinary applications. Arch. Comput. Methods Eng. 2010, 17/3, 253–297. [Google Scholar] [CrossRef]
  31. Ryzhakov, P.; Cotela, J.; Rossi, R.; Oñate, E. A two-step monolithic method for the efficient simulation of incompressible flows. Int. J. Numer. Methods Fluids 2014, 74, 919–934. [Google Scholar] [CrossRef]
  32. Brandt, A.; Livne, O. Multigrid Techniques: 1984 Guide with Applications to Fluid Dynamics, Revised Edition; SIAM: Philadelphia, PA, USA, 2011. [Google Scholar]
  33. Griebel, M.; Zaspel, P. A multi-GPU accelerated solver for the three-dimensional two-phase incompressible Navier-Stokes equations. Comput. Sci. Res. Dev. 2010, 25, 65–73. [Google Scholar] [CrossRef]
Figure 1. Computational mesh and velocity field at t = 1 s. Solution obtained using the semi-explicit Runge–Kutta scheme.
Figure 1. Computational mesh and velocity field at t = 1 s. Solution obtained using the semi-explicit Runge–Kutta scheme.
Applsci 08 00119 g001
Figure 2. Temporal evolution of the horizontal velocity at (x, y) = (0.75, 0.75). Implicit second order backward differentiation formula (BDF2) scheme.
Figure 2. Temporal evolution of the horizontal velocity at (x, y) = (0.75, 0.75). Implicit second order backward differentiation formula (BDF2) scheme.
Applsci 08 00119 g002
Figure 3. Temporal evolution of the horizontal velocity at (x, y) = (0.75, 0.75). Semi-explicit Runge–Kutta scheme.
Figure 3. Temporal evolution of the horizontal velocity at (x, y) = (0.75, 0.75). Semi-explicit Runge–Kutta scheme.
Applsci 08 00119 g003
Figure 4. Error at t = 1 s against the time step, logarithmic scale.
Figure 4. Error at t = 1 s against the time step, logarithmic scale.
Applsci 08 00119 g004
Figure 5. Computational time of different solution steps. Semi-explicit vs. implicit method. Mesh of 6500 nodes.
Figure 5. Computational time of different solution steps. Semi-explicit vs. implicit method. Mesh of 6500 nodes.
Applsci 08 00119 g005
Figure 6. Computational time of different solution steps. Semi-explicit vs. implicit method. Mesh of 160,000 nodes.
Figure 6. Computational time of different solution steps. Semi-explicit vs. implicit method. Mesh of 160,000 nodes.
Applsci 08 00119 g006

Share and Cite

MDPI and ACS Style

Ryzhakov, P.; Marti, J. A Semi-Explicit Multi-Step Method for Solving Incompressible Navier-Stokes Equations. Appl. Sci. 2018, 8, 119. https://doi.org/10.3390/app8010119

AMA Style

Ryzhakov P, Marti J. A Semi-Explicit Multi-Step Method for Solving Incompressible Navier-Stokes Equations. Applied Sciences. 2018; 8(1):119. https://doi.org/10.3390/app8010119

Chicago/Turabian Style

Ryzhakov, Pavel, and Julio Marti. 2018. "A Semi-Explicit Multi-Step Method for Solving Incompressible Navier-Stokes Equations" Applied Sciences 8, no. 1: 119. https://doi.org/10.3390/app8010119

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop