Volume 3, Issue 6 e1188
SPECIAL ISSUE PAPER
Full Access

A numerical method for solution of incompressible Navier–Stokes equations in streamfunction-vorticity formulation

Saad Raza

Saad Raza

Department of Mathematic, COMSATS University Islamabad, Islamabad, Pakistan

Search for more papers by this author
Abdul Rauf

Abdul Rauf

Department of Mathematic, COMSATS University Islamabad, Islamabad, Pakistan

Search for more papers by this author
Jamilu Sabi'u

Jamilu Sabi'u

Department of Mathematic, COMSATS University Islamabad, Islamabad, Pakistan

Department of Mathematics, Yusuf Maitama Sule University Kano, Kano, Nigeria

Search for more papers by this author
Abdullah Shah

Corresponding Author

Abdullah Shah

Department of Mathematic, COMSATS University Islamabad, Islamabad, Pakistan

Correspondence Abdullah Shah, Department of Mathematics, COMSATS University Islamabad, 45550 Islamabad, Pakistan.

Email: [email protected]

Search for more papers by this author
First published: 26 August 2021
Citations: 6

Funding information: Higher Education Commission, Pakistan, NRPU No. 7781; Pakistan Science Foundation, PSF No. 5651

Abstract

In this work, we have proposed a numerical approach for solving the incompressible Navier–Stokes equations in the streamfunction-vorticity formulation. The numerical scheme is based on the diagonally implicit fractional-step θ (DIFST) method used for the time discretization and the conforming finite element method for the spatial discretization. The accuracy and efficiency of the scheme are validated by solving some benchmark problems. The numerical simulations are carried out using the DUNE-PDELab open-source software package. The comparison of DIFST scheme with different time discretization schemes is provided in terms of CPU time. Also, different solvers with preconditioners are investigated for solving the resulting algebraic system of equations numerically.

1 INTRODUCTION

The numerical study of partial differential equations (PDEs) is central to a wide variety of applications in science, and engineering. They are employed to simulate the physical phenomena such as fluid flow, electrostatics, the propagation of heat or sound, elasticity, electrodynamics, and so forth. There is increasing interest in the numerical study of large-scale nonlinear PDEs, whose exact or approximate analytical solutions are difficult to calculate. Therefore, efficient and accurate numerical methods such as the finite element, the finite difference, the volume methods, and the spectral methods are some generally adopted numerical scheme for solving such equations. However, the finite difference methods give poor approximation between grid points while the finite element method use basis functions that are non-zero on small subdomains. Particularly, in computational fluid dynamics (CFD), the high-order finite element methods have gained greater attention in solving problems with complex geometries.1 The CFD methods are becoming an important alternative to experiments for solving several fundamental and practical problems in fluid dynamics.2 The incompressible Navier–Stokes equations (INSEs) are a system of PDEs that are fundamental in CFD.3, 4

There are many numerical schemes available for solving the INSEs numerically in primitive variables. However, most of the methods require solving the pressure or pressure-correction Poisson equation, which serves to satisfy the continuity equation.5 Although, there are many alternative6, 7 but the streamfunction-vorticity formulation has the advantage of eliminating the pressure as a solution variable with mass conserving properties.8, 9 This formulation has also been used for image inpainting problems.10

In this work, the conforming finite element method11, 12 is used for solving the coupled vorticity transport and Poisson's equation simultaneously.13, 14 The DUNE-PDELab is used for the numerical simulations.15-17 The PDELab is open-source software package for solving PDEs numerically and is based on Distributed and Unified Numerics Environment (DUNE).18

The structure of this article is as follows. In Section 2, the governing equations with appropriate initial and boundary conditions are given. Section 3 describes the variational formulation. Section 4 provides the resulting linear and nonlinear system of equation. Section 5 is based on the temporal discretization. In Section 6, numerical results and stability of the method are provided. The comparison of different solvers and preconditioner matrices are also given. Finally, Section 7 concludes this article.

2 PROBLEM STATEMENT

Consider the incompressible Navier–Stokes equation with streamfunction-vorticity formulation19;
ω t + v · ω = ν Δ ω + f in Ω × , = ( t 0 , t 0 + T ) , ()
ω = Δ ψ in Ω × , ()
ω ( · , t ) = g ( · , t ) on Ω , ()
ψ ( · , t ) = f ( · , t ) on Ω , ()
ω ( · , t ) = ω 0 ( · , t ) at t = 0 , ()
ψ ( · , t ) = ψ 0 ( · , t ) at t = 0 . ()

Here, Ω d (d = 1, 2, 3) is a bounded domain with boundary Ω , ψ is the streamfunction and ω is the vorticity. Further, the ψ = v is the fluid velocity, ν is the kinematic viscosity, and f is external source term. The Dirichlet boundary conditions g ( · , t ) and f ( · , t ) are set for both components of coupled system on boundary Ω . Similarly, ω 0 ( · , t ) and ψ 0 ( · , t ) are initial conditions for both components, respectively.

3 WEAK FORMULATION

For the weak solution, the existence, uniqueness and consistency of solutions, that is, well-posedness in the Hadamard sense, is easier to prove.20 After the multiplication of Equation (1a) with the test function φ 0 and Equation (1b) with the test function φ 1 and using integration by parts, we arrive at the weak formulation:

Find ( u 0 ( t ) , u 1 ( t ) ) U 0 × U 1 such that:
d t ( u 0 , φ 0 ) 0 , Ω + ( v . u 0 , φ 0 ) 0 , Ω + ν ( u 0 , φ 0 ) 0 , Ω = ( f , φ 0 ) 0 , Ω , φ 0 V 0 , ()
and
( u 1 , φ 1 ) 0 , Ω ( u 0 , φ 1 ) 0 , Ω = 0 , φ 1 V 1 , ()
where the function spaces are given as follow;
U 0 = { φ 0 H 1 ( Ω ) : φ 0 = g on Ω } , V 0 = { φ 0 , H 1 ( Ω ) : φ 0 = 0 on Ω } .
Similarly,
U 1 = { φ 1 H 1 ( Ω ) : φ 1 = g on Ω } , V 1 = { φ 1 , H 1 ( Ω ) : φ 1 = 0 on Ω } .
We used the notation of the L 2 inner product ( u , φ ) 0 , Ω = Ω u φ d x . An equivalent formulation to Equation (3) that hides the system structure reads as follows:
d t ( u 0 , φ 0 ) 0 , Ω + ( u 1 · u 0 , φ 0 ) 0 , Ω + ν ( u 0 , φ 0 ) 0 , Ω ( f , φ 0 ) 0 , Ω + ( u 1 , φ 1 ) 0 , Ω ( u 0 , φ 1 ) 0 , Ω = 0 , ( φ 0 , φ 1 ) V 0 × V 1 . ()

Now, we identify the temporal and spatial residual forms from Equations (2) and  (3) as follows;

Temporal residual form:
m N a v i e r ( ( u 0 , u 1 ) , ( φ 0 , φ 1 ) ) = ( u 0 , φ 0 ) 0 , Ω . ()
Spatial residual form:
r N a v i e r ( ( u 0 , u 1 ) , ( φ 0 , φ 1 ) ) = ( u 1 · u 0 , φ 0 ) 0 , Ω + ν ( u 0 , φ 0 ) 0 , Ω ( f , φ 0 ) 0 , Ω + ( u 1 , φ 1 ) 0 , Ω ( u 0 , φ 1 ) 0 , Ω . ()

The spaces U 0 and U 1 can differ as different types of boundary conditions can be incorporated into the ansatz spaces. In this work, both the spaces are constrained by the same Dirichlet boundary conditions.

4 ALGEBRAIC PROBLEM

The conforming finite element method applied to Equation (4) is straightforward.21 We may use the conforming space W h k , d ( 𝒯 h ) of degree k in dimension d for each of the components. Typically, one would choose the same polynomial degree for both components. So we assume that any finite-dimensional space spanned by the basis function;
P h = span { ψ 1 , , ψ i } , Q h = span { ϕ 1 , , ϕ j } ,
We can reformulate the problem as;
u h P h = P h 1 × × P h s , such that r h ( u h , v ) = 0 , v Q h = Q h 1 × × Q h s , ()
where s is the number of components in the system. Expanding the solution u h = j = 1 n ( y ) j ψ j in the basis and hereby introducing the coefficient vector y n . Now we formulate the problem as;
Find the u h U h such that: r h = ( u h , v ) = 0 , v Q h
r j = 1 n ( y ) j ψ j , ϕ i = 0 , i = 1 , , m S ( y ) = 0 ,
where S : n m given by S i ( y ) = r h j = 1 n ( y ) j ϕ j , ψ i is a nonlinear, vector-valued function, m , n N (the total number of vertices in a mesh) and i , j I h (the index set of vertices). The solution of S ( y ) = 0 which is the nonlinear algebraic system of equations is typically calculated by fixed point iteration of the form;
y ( k + 1 ) = y ( k ) λ k H ( y ( k ) ) S ( y ( k ) ) . ()
Here H ( y ( k ) ) is a preconditioner matrix and λ k is a damping factor. For example, in the Newton's method,22
H ( y ( k ) ) = ( J ( y ( k ) ) ) 1 with J ( y ( k ) ) i , j = S i y j ( y ( k ) ) .

We assumed that n = m so that the Jacobian matrix J ( y ( k ) ) is invertible. The Newton's method needs the solution of the linear system J ( y ( k ) ) w = S ( y ( k ) ) in each iteration. So, the resulting linear system can either be solved by direct or iterative linear solvers. In this work, different iterative solvers with various preconditioners are tested as given in Table 3.

5 TEMPORAL DISCRETIZATION

In this section, we discuss the discretization of the temporal part of Equation (2). For the unsteady part, let u 0 L 2 ( t 0 , t 0 + T ; u 0 g + V 0 × V 1 ( t ) ) :
d t ( u 0 , φ 0 ) 0 , Ω + ( v . u 0 , φ 0 ) 0 , Ω + ν ( u 0 , φ 0 ) 0 , Ω + ( u 1 , φ 1 ) 0 , Ω ( u 0 , φ 1 ) 0 , Ω + ( f , ϕ 0 ) 0 , Ω = 0 , ( φ 0 , φ 1 ) V 0 × V 1 ( t ) , t , ()
where V 0 × V 1 ( t ) = { ( φ 0 , φ 1 ) H 1 ( Ω ) : ( φ 0 , φ 1 ) = 0 on Ω } . The initial condition u 0 is a function of x Ω . In a more compact way, this can be written with residual forms Equations (5) and (6) as follows:
d t m N a v i e r ( u 0 , φ 0 ; t ) + r N a v i e r ( u 0 , u 1 ) , ( φ 0 , φ 1 ) ; t = 0 , ( φ 0 , φ 1 ) V 0 × V 1 , t ,
where, d d t is time derivative and r N a v i e r ( u 0 , u 1 ) , ( φ 0 , φ 1 ) ; t depend on time residual form, and the new temporal residual form is m ( u 0 , φ 0 ; t ) = Ω u 0 φ 0 d x . We opted the conforming finite element space W h k , d ( 𝒯 h ) of degree k and the function u 0 h , g ( t ) , which depends on time, such that u 0 h ( t ) U 0 h ( t ) = u 0 h , g ( t ) + U 0 h × U 1 h ( t ) . Therefore, the spatial and temporal residual forms can be approximated as m N a v i e r ( u 0 , φ 0 ; t ) m h N a v i e r ( u 0 h , φ 0 h ; t ) and r N a v i e r ( u 0 , u 1 ) , ( φ 0 , φ 1 ) ; t r h N a v i e r ( u 0 h , u 1 h ) , ( φ 0 h , φ 1 h ) ; t , respectively. Now, we take the system of ordinary differential equations (ODEs) for the integration, divide the time interval to sub-interval which are not necessarily equidistant that is,
= { t 0 } ( t 0 , t 1 ] ( t N 1 , t N ] ,
with t 0 = t 0 , t N = t 0 + T , t k 1 < t k for 1 k N and set the time-step to Δ t k = t k + 1 t k .

One of the simplest ODEs solver is the one-step- θ method23 that reads:

Find u 0 h k + 1 U 0 h ( t k + 1 ) such that:
1 Δ t k ( m h N a v i e r ( u 0 h k + 1 , φ 0 ; t k + 1 ) m h N a v i e r ( u 0 h k , φ 0 ; t k ) ) + θ r h N a v i e r ( u 0 h k , u 1 h k ) , ( φ 0 , φ 1 ) ; t k + ( 1 θ ) r h N a v i e r ( u 0 h k + 1 , u 1 h k + 1 ) , ( φ 0 , φ 1 ) ; t k + 1 = 0 , ( φ 0 , φ 1 ) V 0 × V 1 ( t k + 1 ) . ()

By rearranging the terms of Equation (11), leads to the solution of a nonlinear system with the same structure as before at each time-step.24

Find u 0 h k + 1 U 0 h ( t k + 1 ) such that;
1 Δ t k ( m h ( u 0 h k + 1 , φ 0 ; t k + 1 ) m h ( u 0 h k , φ 0 ; t k ) ) + θ r h ( u 0 h k , u 1 h k ) , ( φ 0 , φ 1 ) ; t k + ( 1 θ ) r h ( u 0 h k + 1 , u 1 h k + 1 ) , ( φ 0 , φ 1 ) ; t k + 1 = 0 , ( φ 0 , φ 1 ) V 0 × V 1 ( t k + 1 ) . ()

By rearranging the terms of Equation (11), leads to the solution of a nonlinear system with the same structure as before at each time-step.24

Find u 0 h k + 1 U 0 h ( t k + 1 ) such that;
m h N a v i e r ( u 0 h k + 1 , φ 0 ; t k + 1 ) + Δ t k θ r h N a v i e r ( u 0 h k , u 1 h k ) , ( φ 0 , φ 1 ) ; t k m h N a v i e r ( u 0 h k , φ 0 ; t k ) + Δ t k ( 1 θ ) r h N a v i e r ( u 0 h k + 1 , u 1 h k + 1 ) , ( φ 0 , φ 1 ) ; t k + 1 = 0 , ( φ 0 , φ 1 ) V 0 × V 1 ( t k + 1 ) . ()

The residual form Equation (12) consists of a linear combination of spatial and of temporal residual forms.

The Runge–Kutta method:

The temporal and spatial residual form can be written as follows25, 26:
  1. u 0 h ( 0 ) = u 0 h k .
  2. For i = 1 , , s , find u 0 h ( i ) u 0 h , g ( t k + d i Δ t k ) + U 0 h ( t k + 1 ) :
    j = 0 s a i j m h u 0 h ( j ) , φ 0 ; t k + d j Δ t k + b i j Δ t k r h ( u 0 h , u 1 h ) , ( φ 0 h , φ 1 h ) ; t k + d j Δ t k = 0 , ( φ 0 , φ 1 ) V 0 × V 1 ( t k + 1 ) .
  3. u 0 h k + 1 = u 0 h ( s ) .
Here, we suppose that the same type of boundary condition hold through ( t k , t k + 1 ] . The s stage scheme is given by:
A = p 10 p 1 s p s 0 p s s , B = q 10 q 1 s q s 0 q s s , d = d 0 , , d s T .

The explicit schemes are characterized by p i j = 0 for j > i and q i j = 0 for j i . The diagonally implicit schemes are characterized by p i j = q i j = 0 for j > i . Without loss of generality it can be assumed that p i i = 1 . Moreover, some diagonally implicit schemes, implemented in this work satisfy q i i = b i .

The Shu–Osher form of Runge–Kutta explicit methods and most implicit Runge–Kutta methods may be brought to the form:
  • One step θ scheme:
    A = 1 1 , B = 1 θ θ , d = 0 , 1 T .
    For the explicit/implicit Euler scheme ( θ { 0 , 1 } ) and for the Crank–Nicolson scheme ( θ = 1 2 ).
  • Heun's second-order explicit method
    A = 1 1 0 1 2 1 2 1 , B = 1 0 0 0 1 2 0 , d = 0 , 1 , 1 T .
  • Alexander's two-stage second-order strongly S-stable method27:
    A = 1 1 0 1 0 1 , B = 0 α 0 0 1 α α , d = 0 , α , 1 T
    with α = 1 2 2 .
  • Fractional step θ scheme28:
    A = 1 1 0 0 0 1 1 0 0 0 1 1 , B = θ ( 1 α ) θ α 0 0 0 θ α θ ( 1 α ) 0 0 0 θ ( 1 α ) θ α ,
    d = 0 , θ , 1 θ , 1 T ,
    three stage second order strongly A-stable scheme. With θ = 1 2 2 , α = 2 θ , θ = 1 2 θ = 1 α = 2 1 . Note also that θ α = θ ( 1 α ) = 2 θ 2 .

With θ  =  1 1 2 2 , the damped Newton method is used to solve the nonlinear system, while we used different linear solvers with preconditioners to solve the resulting system of linear equations.

6 NUMERICAL RESULTS

In this section, the computed results for some test problems are provided.

6.1 Test problem 1:

A test problem in the square domain 0 x , y 1 with an exact solution is chosen with the initial condition as19;
ω ( x , y , 0 ) = 4 c ( y 2 1 ) ( y 2 8 ) sin 2 x 12 c 100 ( y 2 1 ) , ()
ψ ( x , y , 0 ) = 0 . 1 ( y 2 1 ) ( y 2 5 ) ( sin 2 x + 1 100 ) . ()
For finding the accuracy of the method, f, b, and c are chosen such that the Equations (1a) and (1b) have the following exact solution;
ω ( x , y , t ) = 4 c e b t ( y 2 1 ) ( y 2 8 ) sin 2 x 12 c 100 e b t ( y 2 1 ) , ψ ( x , y , t ) = c e b t ( y 2 1 ) ( y 2 5 ) ( sin 2 x + 1 100 ) . ()

For the purpose of numerical simulation, we have chosen b = c = 0 . 1 , N = 33 , and Δ t = 0 . 005 . The computed results given in Tables 1 and  2 are obtained by using the combination of DIFST scheme, Newton's method and preconditioned SSOR BiCG-Stab for time discretization, nonlinear and linear solvers respectively. The computed solutions are shown in Figure 1A,B at time T = 3 and ν = 0 . 01 . In Figure 2, plots over the line are shown for comparison of the computed and exact solutions and a very good agreement is observed.

TABLE 1. L 2 error and convergence rates for different numbers of iterations (ITs) of the streamfunction ( ψ ( t ) )
T b = c Linear ITs Nonlinear ITs L 2 error CPU time (s)
2.0 0.1 14905 14905 1.0712E-03 1.8352e+01
2.5 0.1 17963 17963 3.9923E-04 1.2694e+01
3.0 0.1 21035 21035 1.4879E-04 2.7985e+01
3.5 0.1 23873 23873 5.5456E-05 3.2656e+01
4.0 0.1 26845 26845 2.0668E-05 3.7321e+01
4.5 0.1 29843 29843 7.7027E-06 4.1962e+01
5.0 0.1 32871 32871 2.8712E-07 4.6629e+01
TABLE 2. L 2 error and convergence rates for different numbers of iterations (ITs) of the vorticity ( ω ( t ) )
T b = c Linear ITs Nonlinear ITs L 2 error CPU time (s)
2.0 0.1 14905 14905 2.1144E-02 1.8352e+01
2.5 0.1 17963 17963 7.8807E-03 1.2694e+01
3.0 0.1 21035 21035 2.9371E-03 2.7985e+01
3.5 0.1 23873 23873 1.0946E-03 3.2656e+01
4.0 0.1 26845 26845 4.0799E-04 3.7321e+01
4.5 0.1 29843 29843 1.5206E-04 4.1962e+01
5.0 0.1 32871 32871 5.6677E-05 4.6629e+01
Details are in the caption following the image
Contour plots for computed (A) vorticity and (B) streamfunction
Details are in the caption following the image
Plot over line comparison of exact and computed (A) vorticity (B) streamfunction
Table 3 contains the solution of Equations (1a) and (1b) with different linear solvers. In this study, two different linear solvers and four preconditioners were employed as given in Table 3. The bi-conjugate gradient stabilized (BiCG-stab) method with symmetric successive over relaxation (SSOR) preconditioner gives the less number of iterations, followed by the conjugate gradient (CG) method with SSOR as a preconditioner. However, BiCG-stab with the Jacobi method as preconditioner is also promising with 15 number of iterations. The CG method with a Jacobi preconditioner produced 30 number of iterations and lastly the BiCG-stab method with Richardson as preconditioner has the largest number of iterations. Furthermore, with regards to the computational time, the BiCG-stab with SSOR has the less CPU time, followed by CG with Jacobi, the BiCG-stab with Jacobi, CG with SSOR, and lastly the BiCG-stab with Richardson. In terms of accuracy, we computed the L 2 error and observed that the BiCG-stab solver with a SSOR preconditioner gives best accuracy, followed by the CG method with SSOR, BiCG-stab with Jacobi, CG with Jacobi, and in last BiCG-stab with Richardson as a preconditioner. The grid refinement results and orders of accuracy for the proposed scheme are shown in Table 4. The following formula is used to determine the order of accuracy O A :
O A = ln ( e 1 / e 2 ) ln 2 ,
where
e 1 = ϕ e ϕ f e 2 = ϕ e ϕ c
TABLE 3. Comparison for number of iterations, computational costs (in seconds(s)) and L 2 error of different linear solver with preconditioners
Solver Preconditioner Iterations CPU time (s) L 2 error ( ψ ( t ) )
BiCG-Stab Jacobi 15 0.006268 3.1844E-06
CG SS0R 14 0.004509 2.9437E-06
BiCG-Stab SSOR 10 0.003774 2.8712E-07
CG Jacobi 30 0.005511 4.0760E-06
BiCG-Stab Richardson 224 0.031864 7.6456E-06
TABLE 4. Convergence rate for the L 2 error
Grid size L 2 error O A
32 × 32 1.26E-02
64 × 64 1.56E-03 3.01
128 × 128 1.91E-04 3.02
256 × 256 2.26E-05 3.07
512 × 512 2.83E-06 2.99

The exact solution is ϕ e , the solution on a fine grid is ϕ f , and the solution on a coarse grid is ϕ c . It is shown that the order of accuracy for the proposed scheme is 3.

6.1.1 Numerical stability:

Next, we discuss the numerical stability of the different time discretization schemes. All these results are taken by keeping viscosity fixed ν = 0 . 01 , number of nodes N = 33 and with different values of Δ t from time T = 0 to T = 3 . In Table 5, the computational cost is presented in terms of CPU time. We have observed that diagonally implicit fractional-step θ scheme is more efficient and stable, while the explicit schemes are unstable for Δ t 1 0 4 .

TABLE 5. Computational costs (in seconds(s)) for different time discretization schemes
Scheme Δ t = 1 0 4 Δ t = 1 0 3 Δ t = 1 0 2 Δ t = 1 0 1
DIFST 1.1947e+02 1.1157e+01 1.1068e+00 1.1513e−01
Implicit Euler 3.6316e+02 3.7706e+01 3.9438e+00 3.8905e 01
Crank Niklson 1.1859e+03 1.1848e+02 1.1743e+01 1.2086e+00
Alexander (order 2) 8.0120e+02 7.6602e+01 7.5474e+00 7.7801e 01
Alexander (order 3) 1.1362e+03 1.1475e+02 1.1448e+01 1.1779e+00
Heun's Fails Fails Fails Fails
Shu third-order Fails Fails Fails Fails

6.2 Test problem 2: The Taylor–Green vortex problem

We consider the two dimensional Taylor-Green vortex problem in the square domain, Ω = ( 0 , 2 π ) 2 .29 The exact solution is;
ω ( x , y , t ) = 2 cos x cos y e 2 ν t , ()
and
ψ ( x , y , t ) = cos x cos y e 2 ν t . ()
The initial conditions are
ω ( x , y , 0 ) = 2 cos x cos y , ()
and
ω ( x , y , 0 ) = cos x cos y . ()

The periodic boundary conditions are imposed in both the x and y directions. The source term is given by f = 0 . For this problem, we show the results for the ν = 0 . 01 , Δ x = 0 . 005 and time T = 1 . The comparison between the computed results are shown in Figures 3 and  4 which shows the good agreement with the exact solution. The computed results given in Tables 6 and  7 are obtained by using the combination of DIFST scheme, Newton's method and preconditioned SSOR BiCG-stab for time discretization, nonlinear and linear solvers respectively.

Details are in the caption following the image
Contour plot for (A) computed vorticity and (B) exact vorticity
Details are in the caption following the image
Contour plot for (A) computed streamfunction and (B) exact streamfunction
TABLE 6. L 2 error and convergence rates for different numbers of iterations (ITs) of the streamfunction ( ψ ( t ) )
T ν Linear ITs Nonlinear ITs L 2 error CPU time (s)
2.0 0.01 2237 2237 1.3174E-03 4.9459e+00
2.5 0.01 2790 2790 3.7607E-04 6.1735e+00
3.0 0.01 3357 3357 3.9371E-05 7.3951e+00
3.5 0.01 3924 3924 1.7006E-05 8.6268e+00
4.0 0.01 4484 4484 2.0979E-06 9.8551e+00
4.5 0.01 5044 5044 5.2207E-07 1.1071e+01
5.0 0.01 5603 5603 6.4533E-07 1.2297e+01
TABLE 7. L 2 error and convergence rates for different numbers of iterations (ITs) of the vorticity ( ω ( t ) )
T ν Linear ITs Nonlinear ITs L 2 error CPU time (s)
2.0 0.01 2237 2237 1.2364E-02 4.9459e+00
2.5 0.01 2790 2790 1.0807E-03 6.1735e+00
3.0 0.01 3357 3357 3.0361E-04 7.3951e+00
3.5 0.01 3924 3924 1.7649E-05 8.6268e+00
4.0 0.01 4484 4484 2.0789E-06 9.8551e+00
4.5 0.01 5044 5044 1.4256E-06 1.1071e+01
5.0 0.01 5603 5603 1.0012E-06 1.2297e+01

6.3 Test problem 3: 2D Lid driven cavity flow

In the following problem, the flow is given by moving the top lid boundary with constant speed u = 1 with no-slip boundary conditions on the other walls of square domain while the pressure is extrapolated from the interior. The configuration of geometry and boundary condition are shown in Figure 5. The computational domain for this problem is a square with edges of unit length.

Details are in the caption following the image
Flow configuration of classical lid driven cavity

In Figure 6A,B, the vorticity contours at T = 25 for R e = 100 and R e = 400 are given. Similarly, in Figure 7A,B, the vorticity contours at T = 25 for R e = 1000 and R e = 5000 are given. We observed both results have shown good agreement especially in terms of computational cost with the existing results in literature .

Details are in the caption following the image
Streamline contours at Re = 100 and Re = 400 respectively
Details are in the caption following the image
Streamline contours at Re = 1000 and Re = 5000 respectively

In Figure 8A,B, the comparison of vorticity contours at T = 25 for R e = 100 are given which shows the good agreement with result in Reference 30.

Details are in the caption following the image
Vorticity contours at Re = 100. (A) Computed results (left) (B) Result in30 (right)

6.3.1 Numerical stability:

Next, we discuss the numerical stability of the different time discretization schemes. All these results are taken by keeping viscosity fixed ν = 0 . 001 , with Δ t = 0 . 25 and from time T = 0 to T = 25 . In Table 8, the computational cost is presented in terms of CPU time. We have observed that DIFST scheme is more efficient and stable.

TABLE 8. Computational costs (in seconds(s)) of different schemes for different number of iterations
Scheme CPU time ( Δ t = 0 . 25 ) Linear ITs Nonlinear ITs
DIFST 2.0188e+02 12245 245
One step θ 2.2251e+02 13467 298
Crank Niklson 2.1230e+02 20261 307
Alexander (order 2) 3.8680e+02 21307 516
Alexander (order 3) 7.2525e+03 34532 749
Heun's Fails Fails Fails
Shu third-order Fails Fails Fails

7 CONCLUSIONS

This article presents a numerical scheme for solving the two-dimensional unsteady incompressible Navier–Stokes equations by using the conforming finite element method. The diagonally implicit fractional step θ scheme for the temporal discretization is used. By the damped Newton method, the non-linear system of equation is solved. While the linear system of equations is solved by implementing different linear solver with preconditioners. It is observed that BiCG-stab with preconditioner SSOR gave efficient results based on the number of iterations and L 2 error. The accuracy of the scheme is given by computing the L 2 error norm. For the time-dependent solution, the robustness and efficiency of the DIFST scheme are demonstrated by comparing it with other time discretization schemes. A comparison of different linear solvers with preconditioners are given in terms of the number of iterations, the L 2 error norm and CPU time. The DUNE-PDELab open source software is used for all the numerical computations.

ACKNOWLEDGMENTS

Part of this work was carried out during the visit of S. Raza to the University of Heidelberg under the Post-Bachelor program of HGS MATHCOMP. The support of Prof. Peter Bastian and Mr. Linus Seelinger from IWR is highly acknowledged. The work of A. Shah, A. Rauf was supported by HEC under NRPU No. 7781 and S. Raza by PSF No. 5651.

    CONFLICT OF INTEREST

    The authors declare no potential conflict of interests.

    Biographies

    • Saad Raza received MS and BS in Mathematics from COMSATS University Islamabad, Pakistan. Currently, he is working as Research Assistant in the Department of Mathematics, COMSATS University Islamabad, Pakistan. His research interests is in Applied & Computational Mathematics and Numerical solution of Partial Differential Equations.

    • Abdul Rauf was a research student at COMSATS University in Islamabad, Pakistan. He does research on numerical techniques for solving systems of nonlinear equations and partial differential equations.

    • Jamilu Sabi'u is a research student at COMSATS University in Islamabad, Pakistan. He does research on numerical techniques for solving systems of nonlinear equations and partial differential equations. He had almost 30 publications published in reputable journals.

    • Dr. Abdullah Shah received PhD in Computational Mathematics from Institute of Computational Mathematics, Scientific/Engineering Computing, Chinese Academy of Sciences in 2008. Currently, he is working as Head and Associate Professor in the Department of Mathematics, COMSATS University Islamabad, Pakistan and involved in teaching, research, and administration. His research interests span Applied & Computational Mathematics, Modeling & Simulations, and Computational Fluid Dynamics. He is the author of several research articles published in reputed journals. Also, he is the recipient of prestigious Erasmus Mundus (EMMA) postdoctoral fellowship at Interdisciplinary Center for Scientific Computing (IWR), University of Heidelberg, Germany, in 2014, "TWAS-UNESCO Associate" (2013–2016) and CAS President's International Fellowship Initiative "Visiting Scientist" (2018–2019) at Chinese Academy of Sciences. He is HEC approved supervisor in mathematics and supervising BS/MS and PhD students.

      The full text of this article hosted at iucr.org is unavailable due to technical difficulties.