Next Article in Journal
The Rescaled Pólya Urn and the Wright—Fisher Process with Mutation
Next Article in Special Issue
Chaos for the Dynamics of Toeplitz Operators
Previous Article in Journal
Diffusion Model of Parallel Plate Crack Grouting Based on Foaming Expansion Characteristics of Polymer Slurry
Previous Article in Special Issue
Motion of an Unbalanced Impact Body Colliding with a Moving Belt
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Numerical Modeling of the Leak through Semipermeable Walls for 2D/3D Stokes Flow: Experimental Scalability of Dual Algorithms

by
Jaroslav Haslinger
1,2,†,
Radek Kučera
1,2,†,
Kristina Motyčková
2,*,† and
Václav Šátek
2,3,†
1
Faculty of Mechanical Engineering, VŠB-TUO, 17. Listopadu 2172/15, 708 00 Ostrava-Poruba, Czech Republic
2
IT4Innovations, VŠB-TUO, Studentská 6231/1B, 708 00 Ostrava-Poruba, Czech Republic
3
Faculty of Information Technology, Brno University of Technology, Božetěchova 1/2, 612 66 Brno, Czech Republic
*
Author to whom correspondence should be addressed.
These authors contributed equally to this work.
Mathematics 2021, 9(22), 2906; https://doi.org/10.3390/math9222906
Submission received: 6 October 2021 / Revised: 3 November 2021 / Accepted: 8 November 2021 / Published: 15 November 2021
(This article belongs to the Special Issue Theory and Application of Dynamical Systems in Mechanics)

Abstract

:
The paper deals with the Stokes flow subject to the threshold leak boundary conditions in two and three space dimensions. The velocity–pressure formulation leads to the inequality type problem that is approximated by the P1-bubble/P1 mixed finite elements. The resulting algebraic system is nonsmooth. It is solved by the path-following variant of the interior point method, and by the active-set implementation of the semi-smooth Newton method. Inner linear systems are solved by the preconditioned conjugate gradient method. Numerical experiments illustrate scalability of the algorithms. The novelty of this work consists in applying dual strategies for solving the problem.

1. Introduction

The no-slip condition is the standard boundary condition in mathematical fluid flow models. It expresses the fact that a fluid adheres to the surface S, i.e., the velocity u = 0 on S. Nevertheless, in many situations a motion of the fluid on S such as a slip along impermeable S or a leak through semipermeable S can be observed. The Navier slip condition is the simplest one [1]: σ t = k u t , where k > 0 is the adhesive coefficient, σ t , u t denotes the shear stress, and the tangential component of u, respectively. From its form we see that the fluid starts to slip whenever σ t 0 . However, this is not the case, in general. For example, a water drop on an inclined plane which is coated by a non-wetting (hydrophobic) material (teflon, e.g.,) slips only if the angle inclination reaches a specific value. Similarly, a leak of a fluid through semipermeable S may occur only if the magnitude of the stress vector σ (or some of its components) on S attains a certain critical value. The true slip or leak boundary conditions should reflect this threshold behavior. To this end one can use tools of convex analysis and write them in a compact form as inclusions for set-valued mappings, defined by the subgradient of appropriate convex functionals [2]. The overview of different threshold slip laws is presented and discussed in [3]. Since “slip” in fluid mechanics is a synonym for “friction” in solid mechanics (in particular in contact mechanics), it is not surprising that friction and slip models use the same terminology. The weak form of mathematical models under threshold slip or leak conditions leads to a variational inequality type problem, intricacy of which depends on the used law. The simplest one is the threshold slip and leak condition of the Tresca type defined by:
( slip ) | σ t | g , u t 0 then σ t = g u t | u t | on S ,
and
( leak ) | σ n | g , u n 0 then σ n = g u n | u n | on S ,
respectively, where g is an a-priori given threshold bound, | · | stands for the absolute value of a real number or the Euclidean norm in (1) for 3D problems. The Stokes system under (1) and (2) has been studied by Fujita [4,5] and by Roux [6] who considered more general slip models, in which the bound g may depend on | u t | . Despite the fact that the mathematical analysis of this class of problems began relatively late (compared with friction problems of contact mechanics), a lot of theoretical papers on this topic has appeared during past twenty years. Results have been extended to other fluid models and slip conditions such as the steady and unsteady Stokes and Navier–Stokes equations, Coulomb’s type friction law [7,8,9,10,11] and the references therein. The Signorini unilateral boundary conditions [12]:
u n + g 0 , σ n + σ 0 , ( u n + g ) ( σ n + σ ) = 0 on S ,
with given g, σ is another type of conditions which leads to an inequality formulation. The authors used (3) in [13,14] as the artificial outflow conditions prescribed on a part of the boundary to model the blood flow in large arteries.
One of difficulties we face in numerical solution of variational inequalities is the fact that problems are generally nonsmooth and consequently, appropriate computational methods have to be used [15,16]. For the Stokes or Navier–Stokes system with slip or leak conditions nonsmoothness is caused by the presence of the nondifferentiable functional j whose subgradient defines (1) or (2). In the case of the Signorini conditions nonsmoothness is due to the kinematical constraint u n + g 0 on S which imposes additional restrictions on the set of admissible velocity fields. The velocity–pressure formulation of such problems is discretized using a pair of finite element spaces satisfying the Babuska–Brezzi condition [17,18]. One way to handle the nondifferentiable term j, the kinematical constraint in (3), is to use a regularization of j and a smooth penalization of the constraint, respectively in order to transform originally the nonsmooth problem into a sequence of smooth ones, which can be solved by standard methods. The regularization of j has been used in [19], and the penalty method in [13]. Another and the most frequent way of releasing constraints and the nonsmooth character of mathematical models is based on a dualization approach. In the case of the Stokes and Navier–Stokes system, this leads to the weak velocity–pressuretype formulation which is enhanced by the additional Lagrange multipliers. The resulting weak formulation is formally the same as the Karush–Kuhn–Tucker conditions in saddle point problems. The majority of papers devoted to the convergence/error analysis of this class of problems uses just the dualization approach [20,21,22,23,24,25,26,27]. Moreover, there exists a wide range of numerical methods for efficient computational realization of the resulting algebraic models [16].
The present paper is devoted to computational aspects of the Stokes problem with threshold leak conditions. We use the dual strategy, i.e., the velocity component is eliminated from an appropriate mixed finite element discretization of 2D and 3D problems. Our aim is to develop efficient algorithms for solving resulting algebraic systems which are satisfied by the dual variables, namely by the discrete pressure, shear and the normal stress on S, in our case. Let us note that this approach is frequently used in contact problems of solid mechanics. However, its simple transfer to problems of fluid mechanics is not possible due to the presence of the incompressibility condition prescribed in the whole computational domain. The modified path–following (PF) variant of the interior point method has been used in [27] for solving 2D Stokes system with threshold slip conditions, and in [28] for 3D problems. In addition, the latter paper uses also the semi-smooth Newton (SSN) and compares it with the PF method. Although numerical experiments demonstrated the scalable behavior of both approaches, the SSN method turned out to be more efficient because of its simpler implementation. Similar numerical tests and comparisons of SSN and PF will be done in the present paper. It is hard to predict the computational efficiency in advance, since the discrete threshold leak conditions in 2D and 3D problems always lead to simple box constraints unlike the separable spherical constraints in the case of the threshold slip in 3D. Another important feature is the fact that the dual algebraic formulations involve relatively a small number of constrained unknowns. This excludes the efficient use of some types of algorithms such as strictly feasible minimization methods based on an active-set strategy [29]. It has been found in [27] for 2D problems that they are less efficient than the PF method. The inefficiency is more significant for large-scale 3D problems. The main benefit of this work is an application of dual strategies for solving the problem. The methods presented in this paper may be easily modified for parallelization based on the FETI domain decomposition technique [30].
The paper is organized as follows. In Section 2 we present the classical and several weak formulations of the problem. The mixed finite element approximation based on the P1-bubble/P1 finite element pair is introduced in Section 3. The resulting algebraic problems are starting point for constructing of algorithms in Section 4. Finally, Section 5 contains results of numerical experiments, including the problems with non-unique solutions. Concluding remarks are summarized in Section 6.
The following notation is used in the paper: H k ( Ω ) , k 0 integer, stands for the Sobolev space of functions defined in Ω which are together with their generalized derivatives up to order k square integrable in a domain Ω d ( H 0 ( Ω ) = L 2 ( Ω ) ) . The scalar product in L 2 ( Ω ) will be denoted by ( , ) . L + 2 ( Ω ) denotes the set of non-negative functions from L 2 ( Ω ) . If γ is a part of the boundary of Ω then H 1 2 ( γ ) is the trace space on γ of functions belonging to H 1 ( Ω ) . The space of p × q matrices is denoted by p × q , p : = p × 1 is the space of p-dimensional vectors, and + p denotes the non-negative orthant of p . Bold characters are used for vectors and matrices. By 0 we denote the zero matrix, or vector. Further I p × p stands for the identity matrix. The scalar product of two vectors a , b p , is denoted by a · b . If A = ( a i j ) p × q , B = ( b i j ) p × q are two matrices then A : B = a i j b i j (summation convention is used). Caligraphic symbols will be used for index sets, for instance: N = { 1 , 2 , , n } and A , I N . If N p × q and A , then N A | A | × q stands for the matrix given by the rows of N whose indices belong to  A . If A p × p is symmetric, positive definite with the smallest, and largest eigenvalues 0 < α min α max , respectively, then the spectral condition number of A is c o n d ( A ) = α max / α min . The indicator matrix of a subset S N is the diagonal matrix D ( S ) = d i a g ( s 1 , s 2 , , s p ) p × p , where s i = 1 for i S and s i = 0 if i S . Finally, the symbol · stands for the Euclidean norm in p , p 2 .

2. Setting of the Problem

The aim of this section is to recall the classical formulation of the Stokes system with leak boundary conditions and to present several weak formulations of this problem together with main existence/uniqueness results.
Let Ω d , d { 2 , 3 } be a bounded domain with the Lipschitz boundary Ω which is decomposed into two nonempty, nonoverlapping parts Γ and S both open in Ω . The classical formulation of the problem reads as follows: find the velocity vector u : Ω d and the pressure p : Ω satisfying the following system of differential equations and boundary conditions:
2 μ div ( 𝔻 u ) + p = f in Ω , div u = 0 in Ω , u = 0 on Γ , u t = 0 on S , | σ n | g on S , u n 0 | σ n | = g & u n σ n 0 on S .
Here μ > 0 is the viscosity of the fluid, f : Ω d , g : S + denote an external force, and a nonnegative leak threshold, respectively. Further 𝔻 u = 1 2 ( u + ( u ) ) is the symmetric part of the gradient of u, n stands for the unit, outward normal vector to Ω , u n = u · n , u t = u u n n is the normal, and the tangential component of u on Ω , respectively. Similarly, σ n = 2 μ 𝔻 u n · n p is the normal component of the stress vector σ = 2 μ 𝔻 u n p n on Ω . It is worth noticing that unlike the shear stress σ t = σ σ n n , the normal component σ n depends explicitly on the pressure p. The boundary conditions on S express the fact that there is no slip along S and the fluid can escape from Ω only if the threshold g is attained, i.e., | σ n | = g . In addition, the sign of σ n is opposite to the one of u n .
Remark 1.
The last two conditions in (4) can be written in the following equivalent way:
| σ n | g , σ n u n + g | u n | = 0 on S
or
σ n g | u n | on S ,
where the symbol ∂ stands for the subgradient of convex functions.
To present variational formulations of (4) we shall need the following function spaces and forms:
W ( Ω ) = { v H 1 ( Ω ) d | v = 0 on Γ } , V ( Ω ) = { v W ( Ω ) | v t = 0 on S } , V div ( Ω ) = { v V ( Ω ) | div v = 0 in Ω } ,
and
a ( u , v ) = 2 μ Ω 𝔻 u : 𝔻 v d x , u , v H 1 ( Ω ) d , b ( v , q ) = Ω q div v d x , q L 2 ( Ω ) , v H 1 ( Ω ) d , ( f , v ) = Ω f · v d x , f L 2 ( Ω ) d , v H 1 ( Ω ) d , j ( v n ) = S g | v n | d s , g L + 2 ( S ) , v H 1 ( Ω ) d .
By the weak velocity–pressure formulation of (4) we call a problem of finding a pair ( u , p ) V ( Ω ) × L 2 ( Ω ) such that
a ( u , v u ) + b ( v u , p ) + j ( v n ) j ( u n ) ( f , v u ) v V ( Ω ) , b ( u , q ) = 0 q L 2 ( Ω ) .
From Green’s formula with an appropriate choice of test functions v one can verify that the classical and weak velocity–pressure formulations are equivalent for sufficiently smooth solutions ( u , p ) ([5]).
Restricting to test functions v V d i v ( Ω ) we arrive at the weak velocity formulation of (4):
u V div ( Ω ) : a ( u , v u ) + j ( v n ) j ( u n ) ( f , v u ) v V div ( Ω ) ,
which is equivalent to the following minimization problem:
u argmin { J ( v ) , v V d i v ( Ω ) } ,
where
J ( v ) = 1 2 a ( v , v ) + j ( v n ) ( f , v ) .
Problem (8) is the variational inequality of the second kind and it has a unique solution u [15].
The following existence/uniqueness result has been established in [4,5].
Theorem 1.
Problem (6) has a solution ( u , p ) for any f L 2 ( Ω ) d and g L + 2 ( S ) . The velocity vector u is unique. If there is a set ω S , m e a s d 1 ω > 0 such that | σ n | = g on ω then the pressure p is unique, as well, otherwise p is determined up to constants c satisfying | σ n + c | g a.e. on S.
Remark 2.
If, besides Γ and S there is a portion Γ N Ω , m e a s d 1 Γ N > 0 , where the value of σ is prescribed, i.e., σ = σ N L 2 ( Γ N ) d given, then also p is unique.
Remark 3.
It has been shown in [5] that, if p is not unique, then the range of the admissible constants c satisfying | σ n + c | g a.e. on S is the interval k 1 , k 2 , where k 1 = sup S ( σ n g ) , k 2 = inf S ( σ n + g ) , provided that the solution ( u , p ) is smooth enough.
The last formulation presented in this section is the variant of the velocity–pressure formulation (6) in which the Lagrange multipliers are used to release the no-slip condition u t = 0 on S and to regularize the nonsmooth term j. To this end we shall need the following trace spaces:
X t = { ϕ L 2 ( S ) d 1 | v W ( Ω ) : ϕ = v t on S } , X n = { μ L 2 ( S ) | v W ( Ω ) : μ = v n on S }
and their duals X t , X n . If Ω is the domain with a smooth boundary ( C 1 , 1 , e.g.,), then X t = ( H 1 2 ( S ) ) d 1 and X n = H 1 2 ( S ) .
Remark 4.
If the solution ( u , p ) is sufficiently smooth, then the normal and shear components of σ on S have been defined pointwisely at the beginning of this section. If no regularity assumptions are imposed on ( u , p ) then σ n and σ t have to be understood as elements of X n and X t , respectively, defined by
σ t , v t : = a ( u , v ) + b ( v , p ) ( f , v ) v W ( Ω ) , v n = 0 on S ,
σ n , v n : = a ( u , v ) + b ( v , p ) ( f , v ) v W ( Ω ) , v t = 0 on S ,
where the , stands for the duality pairings. It is easy to see that the right hand sides of (9) and (10) depend only on v t , and v n on S, respectively, since ( u , p ) V div ( Ω ) × L 2 ( Ω ) solves the Stokes system in a weak sense. Moreover, σ n belongs to L 2 ( S ) and it satisfies the last two conditions on S in (4). Indeed,
j ( v n ) j ( u n ) σ n , v n u n v V ( Ω ) σ n j ( u n ) a . e . o n S .
The duality pairing σ n , v n is defined by the L 2 ( S ) -scalar product in this case.
Finally, let
K = { ν L 2 ( S ) | | ν | g a . e . o n S }
be a closed, convex subset of L 2 ( S ) . To derive the new formulation we use the saddle-point approach. It holds:
J ( u ) = min v V d i v ( Ω ) J ( v ) = min v V ( Ω ) sup q L 2 ( Ω ) { J ( v ) + b ( v , q ) } = min v W ( Ω ) sup q L 2 ( Ω ) sup τ X t ν K { J ( v ) + b ( v , q ) τ , v t ν , v n } : = min v W ( Ω ) sup q L 2 ( Ω ) sup τ X t ν K L ( v , q , τ , ν ) ,
where L : Q , Q = W ( Ω ) × L 2 ( Ω ) × X t × K is the Lagrangian. Suppose there exists a saddle-point ( u , p , τ , ν ) Q of L on Q:
L ( u , q , τ , ν ) L ( u , p , τ , ν ) L ( v , p , τ , ν ) ,
that holds for every ( v , p , τ , ν ) Q .
It is known (see [2]) that the necessary and sufficient condition for ( u , p , τ , ν ) to be a saddle-point of L on Q is the satisfaction of the Karush–Kuhn–Tucker conditions:
a ( u , v ) + b ( v , p ) = ( f , v ) + τ , v t + ν , v n v W ( Ω ) , b ( u , q ) = 0 q L 2 ( Ω ) , τ , u t = 0 τ X t , ν + ν , u n 0 ν K .
It is easy to see that ( u , p ) V d i v ( Ω ) × L 2 ( Ω ) satisfies the Stokes system and the boundary conditions on Ω , i.e., ( u , p ) solves (6). Moreover, τ = σ t , ν = σ n is the corresponding shear, and normal stress on S, respectively. The opposite assertion is also trivial: if ( u , p ) V ( Ω ) × L 2 ( Ω ) is a solution to (6), then the quadruplet ( u , p , σ t , σ n ) W ( Ω ) × L 2 ( Ω ) × X t × K solves (11), where σ t , σ n is the corresponding shear, and normal stress on S, respectively.
Theorem 2.
A couple ( u , p ) V ( Ω ) × L 2 ( Ω ) solves (6) if and only if the quadruplet ( u , p , σ t , σ n ) Q is a solution to (11).
Proof is straightforward. For more details we refer to [31].
Remark 5.
In the discrete counterpart of the problem we shall use the following more general form j κ instead of j:
j κ ( v n , w n ) = S g | v n | + κ w n v n d s , g , κ L + 2 ( S ) , v , w H 1 ( Ω ) d .
Then the weak formulation (6) is modified as follows: find a pair ( u , p ) V ( Ω ) × L 2 ( Ω ) such that
a ( u , v u ) + b ( v u , p ) + j κ ( v n , u n ) j κ ( u n , u n ) ( f , v u ) v V ( Ω ) , b ( u , q ) = 0 q L 2 ( Ω ) .
The function κ : S + characterizes pore opening. The respective leak condition reads as
| σ n + κ u n | g , ( σ n + κ u n ) u n + g | u n | = 0 on S .
Therefore the substitution σ ˜ n = σ n + κ u n transforms the leak condition (13) formally into (5) so that all results of this section remain valid also for problem (12).

3. Mixed Finite Element Method and Algebraic Formulations

In this section we present the algebraic form of the problem, which will be used in the subsequent parts of the paper for numerical solution. It is based on the discretization of the velocity–pressure formulation (12) by a mixed finite element method. Next we shall suppose that Ω is a polygonal ( d = 2 ) , or polyhedral ( d = 3 ) domain. If not, then Ω is approximated by them. Let V h W h , Q h be finite element approximations of V ( Ω ) , W ( Ω ) , and L 2 ( Ω ) , respectively, such that the bilinear form b satisfies the Babuska–Brezzi condition:
sup v h W h b ( v h , q h ) v h 1 , Ω β q h 0 , Ω q h Q h ,
where β > 0 does not depend on the discretization parameter h.
The mixed finite element approximation of (12) reads as follows:
Find ( u h , p h ) V h × Q h such that a ( u h , v h u h ) + b ( v h u h , p h ) + j κ ( v n , u n ) j κ ( u n , u n ) ( f , v h u h ) v h V h , b ( u h , q h ) = 0 q h Q h .
In computations we use the P1-bubble/P1 finite element pair [32] on a regular partition T h of Ω ¯ into triangles, tetrahedras for d = 2 , and 3, respectively. On T h we define the finite element spaces:
V h = { v h V ( Ω ) : v h | T ( P 1 ( T ) ) d ( B ( T ) ) d T T h } , Q h = { q h C ( Ω ¯ ) : q h | T P 1 ( T ) T T h } ,
where P 1 ( T ) , B ( T ) are the spaces of polynomials of degree one and of bubble functions of degree three ( d = 2 ) and four ( d = 3 ) on T T h , respectively.
The algebraic counterpart of (14) reads as follows:
Find ( u , p ) 𝕍 × n p such that u T A ( v u ) + ( v u ) T B T p + j κ h ( v , u ) j κ h ( u , u ) b T ( v u ) v 𝕍 , B u = 0
with
𝕍 = { v d ( n u + n q ) : T v = 0 } , j κ h ( v , w ) = g T | N v | + w T N T D κ N v ,
where the absolute value is understood componentwisely, D κ = d i a g ( κ ) , g , κ + n s with n s being the number of nodes belonging to S ¯ Γ ¯ . Here, n p , n u stand for the number of the finite element nodes of T h in Ω ¯ , and Ω ¯ Γ ¯ , respectively, while n q denotes the number of the triangles/tetrahedras in T h . Further, A d ( n u + n q ) × d ( n u + n q ) is a symmetric, positive definite diffusion matrix, B n p × d ( n u + n q ) is a full row-rank divergence matrix, and b d ( n u + n q ) is a vector of nodal forces. The unit outward, normal vector at the i-th node of S ¯ Γ ¯ defines nonzero entries in the i-th row of the matrix N n s × d ( n u + n q ) . For d = 2 , the tangential vector defines nonzero entries in the i-th row of the matrix T n s × 2 ( n u + n q ) . For d = 3 , there are two mutually orthonormal tangential vectors that define nonzero entries in the i-th rows of the matrices T 1 , T 2 n s × 3 ( n u + n q ) . In this case, T = ( T 1 T , T 2 T ) T .
Denote
N = { 1 , , n s }
that is the local index set of the nodes belonging to S ¯ Γ ¯ . The algebraic version j κ h of j introduced above is the result of numerical integration, assuming that g , κ C ( S ¯ ) . For d = 3 we use the following integration formula on the triangular element τ T h | S ¯ with the vertices x i , x j , x k S ¯ :
τ g | v n | d s | τ | g ( x τ ) 1 3 ( | v n ( x i ) | + | v n ( x j ) | + | v n ( x k ) | ) = | τ | g ( x τ ) 1 3 ( | ( N v ) i | + | ( N v ) j | + | ( N v ) k | ) ,
where | τ | = m e a s τ , x τ is the centre of gravity of τ , and ( N v ) i is the i-th component of N v . Summing up (17) over all τ T h | S ¯ we arrive at:
S g | v n | d s g T | N v | with g i : = j = 1 n i | τ j i | 3 g ( x τ j i ) , i N ,
where g = ( g 1 , , g n s ) T and n i is the number of the triangles τ j i T h | S ¯ sharing x i S ¯ Γ ¯ as the common vertex. In the same way we get:
S κ w n v n d s w T N T D κ N v with κ i : = j = 1 n i | τ j i | 3 κ ( x τ j i ) , i N ,
where κ = ( κ 1 , , κ n s ) T . We proceed analogously for d = 2 when τ T h | S ¯ is a line segment, n i 2 , and
g i : = j = 1 n i | τ j i | 2 g ( x τ j i ) , κ i : = j = 1 n i | τ j i | 2 κ ( x τ j i ) , i N .
From this and (16)
j κ h ( v , u ) j κ h ( u , u ) = g T | N v | g T | N u | + u T N T D κ N ( v u ) .
Thus problem (15) can be written in the following equivalent form:
Find ( u , p ) 𝕍 × n p such that u T A κ ( v u ) + ( v u ) T B T p + j h ( v ) j h ( u ) b T ( v u ) v 𝕍 , B u = 0 ,
where
A κ = A + N T D κ N
and
j h ( v ) = g T | N v | .
It is easy to show that the first component u in (20) solves the discrete velocity formulation being the algebraic version of (8):
Find   u 𝕍 B such that J ( u ) J ( v ) v 𝕍 B ,
where
𝕍 B = { v 𝕍 : B v = 0 } , J ( v ) = 1 2 v T A κ v v T b + j h ( v ) .
Formulation (22) is not suited for direct computations, as the constraints in 𝕍 B can be hardly handled for large-scale problems. Moreover, the function J is nondifferentiable caused by the term jh. To overcome these difficulties, we will use the dual formulation of (22) and derive the discrete counterpart of (11).
We introduce three Lagrange multipliers: μ n n s to regularize j h , μ t ( d 1 ) n s , q n p to release the discrete stick, and incompressibility conditions, respectively and denote μ = ( μ n T , μ t T , q T ) T . Let
𝕏 = 𝕏 n × ( d 1 ) n s + n p , 𝕏 n = { μ n n s : | μ n , i | g i , i N } ,
where μ n , i is the i-th component of μ n n s . The term j h can be written as follows:
j h ( v ) = i N max | μ n , i | g i μ n , i ( N v ) i = max μ n 𝕏 n μ n T N v .
Thus:
min v 𝕍 B J ( v ) = min v d ( n u + n q ) max μ 𝕏 L # ( v , μ ) ,
where the Lagrangian L # : d ( n u + n q ) × 𝕏 associated with the velocity Formulation (22) is defined for ( v , μ ) d ( n u + n q ) × 𝕏 by:
L # ( v , μ ) = 1 2 v T A κ v v T b + μ n T N v + μ t T T v + q T B v .
Until now, the velocity vector v d ( n u + n q ) incorporates d n q bubble components. These components are usually eliminated before the computational process [33]. In our case, we perform this elimination in a saddle-point formulation for L # , which leads to the reduced Lagrangian L : d n u × 𝕏 defined by:
L ( v , μ ) = 1 2 v T A κ v v T b + μ n T N v + μ t T T v + q T B v 1 2 q T E q c T q , ( v , μ ) d n u × 𝕏 .
To simplify notation here and in what follows, we use the same symbols for the corresponding matrices and vectors before and after the elimination of the bubble components. The dimensions of the reduced matrices are: A κ d n u × d n u , N n s × d n u , T ( d 1 ) n s × d n u , B n p × d n u , and b d n u . Note that these matrices preserve the same properties as before the elimination, especially, the expression (21) remains valid with A d n u × d n u being symmetric, positive definite. The presence of the symmetric, positive semidefinite matrix E n p × n p and of the vector c n p is due to this elimination. Note that E has the defect one and the eigenvector whose all components are equal to 1 corresponds to zero eigenvalue.
The new saddle-point formulation of (22) reads as follows:
Find ( u , λ ) d n u × 𝕏 such that L ( u , μ ) L ( u , λ ) L ( v , λ ) ( v , μ ) d n u × 𝕏 ,
or, equivalently,
Find ( u , λ ) d n u × 𝕏 such that A κ u + N T λ n + T T λ t + B T p b = 0 , B u E p c = 0 , T u = 0 , | λ n , i | g i , ( N u ) i 0 | λ n , i | = g i & ( N u ) i λ n , i 0 , i N ,
where λ = ( λ n T , λ t T , p T ) T .
Remark 6.
Here, λ n , λ t , p are the discrete counterparts of σ ˜ n (see Remark 5), σ t , and p, respectively. The change of the sign at σ ˜ n and σ t is for convenience of readers. One can see at a glance that the dual Hessian will be positive definite, as C introduced bellow is assembled from matrices without any negative signs.
Now we eliminate the unknown u . Denoting C = ( N T , T T , B T ) T , the first equation in (24) yields u = A κ 1 ( b C T λ ) . Inserting u into the first inequality in (23), we arrive at the dual formulation of (22):
Find λ 𝕏 such that S ( λ ) S ( μ ) μ 𝕏 ,
where S : d n s + n p ,
S ( μ ) = 1 2 μ T F κ μ μ T d
with F κ = C A κ 1 C T + d i a g ( 0 , 0 , E ) being symmetric, positive definite provided that Γ N from Remark 2 is nonempty, and d = C A κ 1 b ( 0 T , 0 T , c T ) T . In what it follows we will assume that F κ is non-singular. The case Γ N = will be discussed in Example 3.
It should be noted that (25) is more convenient for numerical solution unlike (22) as the function S is differentiable (quadratic) and the feasible set 𝕏 is defined by the box constraints. The solution to (25) may be computed by an appropriate algorithm of the constrained minimization. Another way how to solve our problem originates from (24) but with the algebraic leak boundary conditions expressed by projections on appropriate convex sets. The resulting system of nonsmooth algebraic equations can be solved by the nonsmooth Newton type method.

4. Algorithms

The aim of this section is to present main ideas of the path-following and the semismooth Newton methods that turned out to be highly efficient for solving frictional contact problems of solid mechanics [34,35,36]. These algorithms have been adapted for the Stokes system with the threshold slip boundary conditions in 2D [27,37] and 3D [28]. The situation with the threshold leak conditions is different since only box constraints are imposed on the individual components of λ n in 2D, as well as in 3D problems. In view of this fact the same implementation of the path-following method can be used in both cases. Also the semismooth Newton method works only with projections on compact intervals unlike the threshold slip boundary conditions in 3D in which case the components of λ t are pairwise subject to spherical constraints and projections on circles are needed. Consequently, the finite termination property for the semismooth Newton method can be expected also for 3D problems.

4.1. Path-Following Method

Let L : d n s + n p × + 2 n s be the Lagrangian to (25):
L ( μ , ν ) = S ( μ ) + ν 1 T ( g μ n ) + ν 2 T ( μ n g ) ,
where ν : = ( ν 1 T , ν 2 T ) T 2 n s , ν 0 , is the Lagrange multiplier vector releasing the box constraints appearing in 𝕏. Let z k : = ν k L ( μ , ν ) , k = 1 , 2 , z : = ( z 1 T , z 2 T ) T 2 n s be the new variables and define the function H : ( d + 4 ) n s + n p ( d + 4 ) n s + n p ,
H ( ω ) : = ( μ L ( μ , ν ) T , ( ν L ( μ , ν ) + z ) T , e T M Z ) T ,
where ω = ( μ T , ν T , z T ) T ( d + 4 ) n s + n p , M = d i a g ( ν ) , Z = d i a g ( z ) , and e n s is the vector whose all components are equal to 1. The solution λ to (25) is the first component of the vector ω ¯ = ( λ T , ν ¯ T , z ¯ T ) T , which satisfies
H ( ω ¯ ) = 0 , ν ¯ 0 , z ¯ 0 ,
since (27) is equivalent to the Karush-Khun-Tucker conditions for ( λ , ν ¯ ) to be a saddle-point of (26) on d n s + n p × + 2 n s .
To derive the path-following algorithm, we replace (27) by the following perturbed problem:
Find ω τ = ( λ τ T , ν τ T , z τ T ) T ( d + 4 ) n s + n p such that H ( ω τ ) = ( 0 T , 0 T , τ e T ) T , ν τ > 0 , z τ > 0 ,
where τ + . Solutions ω τ to (28) define a curve C ( τ ) in ( d + 4 ) n s + n p called the central path. This curve approaches ω ¯ when τ tends to zero. We combine the damped Newton method used for solving the equation in (28) with an appropriate change of τ which guarantees that the iterations belong to a neighbourhood N ( c 1 , c 2 ) of C ( τ ) defined by:
N ( c 1 , c 2 ) = { ω = ( μ T , ν T , z T ) T ( d + 4 ) n s + n p : ν i z i c 1 ϑ , i = 1 , , 2 n s , ν 0 , z 0 , μ L ( μ , ν ) c 2 ϑ , ν L ( μ , ν ) + z c 2 ϑ } ,
where c 1 ( 0 , 1 ] , c 2 1 , and ϑ : = ϑ ( ω ) = ν T z / ( 2 n s ) . In the k-th iteration, we replace τ : = τ ( k ) by the product of ϑ ( k ) : = ϑ ( ω ( k ) ) with the centering parameter c ( k ) chosen as in [38]. The algorithm uses also the Armijo-type condition (30) ensuring that the sequence { ϑ ( k ) } is monotonically decreasing. By J ( ω ) in (29), we denote the Jacobian matrix of H at ω .
Algorithm PF: Given c 1 ( 0 , 1 ] , c 2 1 , 0 < c min c max 1 / 2 , c 3 ( 0 , 1 ) , and ε 0 . Let ω ( 0 ) N ( c 1 , c 2 ) and set k : = 0 .
(i) 
Choose c ( k ) [ c min , c max ] .
(ii) 
Solve
J ( ω ( k ) ) Δ ω ( k + 1 ) = H ( ω ( k ) ) + ( 0 T , 0 T , c ( k ) ϑ ( k ) e T ) T .
(iii) 
Set ω ( k + 1 ) = ω ( k ) + α ( k ) Δ ω ( k + 1 ) with the largest α ( k ) ( 0 , 1 ] such that ω ( k + 1 ) N ( c 1 , c 2 ) and
ϑ ( k + 1 ) c 3 ( 1 α ( k ) ( 1 c ( k ) ) ) ϑ ( k ) .
(iv) 
Return ω ¯ = ω ( k + 1 ) , if err ( k ) : = ω ( k + 1 ) ω ( k ) / ω ( k + 1 ) ε , else set k : = k + 1 and go to step (i).
The bounds imposed on the parameters mentioned in the initialization section follow from the convergence analysis presented in [34]. The computational efficiency depends on the way how the inner linear systems (29) are solved. The Jacobian matrix is non-symmetric and indefinite with the following block structure:
J ( ω ( k ) ) = F κ J 12 0 J 12 T 0 I 0 Z ( k ) M ( k ) , J 12 = I I 0 0 0 0 .
Eliminating the 2nd and 3rd component of Δ ω ( k + 1 ) , we get the reduced linear system for Δ μ ( k + 1 ) with the Schur complement
S κ ( k ) = F κ + J 12 M ( k ) ( Z ( k ) ) 1 J 12 T .
As μ ( k ) > 0 , z ( k ) > 0 , the matrix S κ ( k ) is symmetric, positive definite and the reduced linear system can be solved by the conjugate gradient method. In order to guarantee its convergence, we use the preconditioner:
P κ ( k ) = D F κ + J 12 M ( k ) ( Z ( k ) ) 1 J 12 T ,
where D F κ = d i a g ( F κ ) . Although S κ ( k ) and P κ ( k ) depend on the k iteration, the eigenvalue bounds of the preconditioned matrix ( P κ ( k ) ) 1 S κ ( k ) are positive and do not depend on k. Consequently, the spectral condition number cond is bounded by (see [34]):
cond ( ( P κ ( k ) ) 1 S κ ( k ) ) cond ( D F κ ) cond ( F κ ) .
In computations, we approximate D F κ replacing A κ 1 in F κ by  diag ( A κ ) 1 , i.e.,
D ˜ F κ = d i a g ( C diag ( A κ ) 1 C T ) + d i a g ( 0 , 0 , d i a g ( E ) ) .
The inequality (32) remains valid also for this choice od D ˜ F κ .
The conjugate gradient method (CGM) used in the k-th step of Algorithm PF is initialized and terminated adaptively. The initial CGM iteration is taken as the computed result in the previous iteration. The CGM iterations are terminated if the relative residuum is less than the bound, depending on the precision achieved in the outer loop err ( k 1 ) and determined by:
tol ( k ) = min { r tol × err ( k 1 ) , c fact × tol ( k 1 ) } ,
where 0 < r tol < 1 , 0 < c fact < 1 , err ( 1 ) = 1 , and tol ( 1 ) = r tol / c fact .

4.2. Semismooth Newton Method

Let P [ a , b ] : [ a , b ] be the projection of ℝ on the interval [ a , b ] , a b , defined by the max-function:
P [ a , b ] ( x ) = x max { 0 , x b } + max { 0 , x + a } , x .
The last two lines in (24) representing the leak condition can be equivalently written as:
λ n , i = P [ g i , g i ] ( λ n , i + ρ i ( N u ) i ) , i N ,
where ρ i > 0 , i N , are arbitrary but fixed parameters. We introduce the new variable s n n s whose components s n , i = κ i ( N u ) i + λ n , i approximate σ n ( x i ) at the nodes x i γ ¯ S γ ¯ D , i N . Then (34) takes the form:
0 = κ i ( N u ) i s n , i + P [ g i , g i ] ( s n , i + ( ρ i κ i ) ( N u ) i ) , i N .
We distinguish two cases:
if κ i = 0 , ρ i = ρ : 0 = s n , i + P [ g i , g i ] ( s n , i + ρ ( N u ) i ) , if κ i > 0 , ρ i = κ i : 0 = κ i ( N u ) i s n , i + P [ g i , g i ] ( s n , i ) , i N .
The equations in (35) can be reformulated using (33). As we prefer the vector notation, we split N into two subsets:
N 0 = { i N : κ i = 0 } , N + = { i N : κ i > 0 }
and introduce the sub-vectors s n , N 0 , s n , N + , g N 0 , g N + and the sub-matrices N N 0 , N N + , D κ + = d i a g ( κ N + ) . Then (35) is equivalent to:
0 = ρ N N 0 u max { 0 , s n , N 0 + ρ N N 0 u g N 0 } + max { 0 , s n , N 0 ρ N N 0 u g N 0 } , 0 = N N + u max { 0 , D κ + 1 ( s n , N + g N + ) } + max { 0 , D κ + 1 ( s n , N + g N + ) } ,
where the max-function is understood component-wisely. The max-function can be efficiently replaced by indicator matrices. First we define inactive/active sets for the second arguments of the max-functions in (36):
I 0 + : = { i N 0 : s n , i + ρ ( N u ) i g i > 0 } , I 0 : = { i N 0 : s n , i ρ ( N u ) i g i > 0 } , A 0 : = N 0 ( I 0 + I 0 ) , I + + : = { i N + : s n , i g i > 0 } , I + : = { i N + : s n , i g i > 0 } A + : = N + ( I + + I + ) .
According to this notation, we introduce the indicator matrices D ( I 0 + ) , D ( I 0 ) , D ( A 0 ) , D ( I + + ) , D ( I + ) , D ( A + ) , respectively. Summarizing, (24) can be written as one equation:
G ( y ) = 0 ,
where G : d ( n u + n s ) + n p d ( n u + n s ) + n p is defined at y = ( u T , s n , N 0 T , s n , N + T , λ t T , p T ) T by
G ( y ) : = A u + N N 0 T s n , N 0 + N N + T s n , N + + T T λ t + B T p b ρ N N 0 u D ( I 0 + ) ( s n , N 0 + ρ N N 0 u g N 0 ) + D ( I 0 ) ( s n , N 0 ρ N N 0 u g N 0 ) N N + u D κ + 1 D ( I + + ) ( s n , N + g N + ) + D κ + 1 D ( I + ) ( s n , N + g N + ) T u B u E p c
using also (21). The standard differentiation rules lead to the following (generalized) Jacobian matrix of G at y :
J G ( y ) = A N N 0 T N N + T T T B T ρ D ( A 0 ) N N 0 D ( I 0 + I 0 ) 0 0 0 N N + 0 D κ + 1 D ( I + + I + ) 0 0 T 0 0 0 0 B 0 0 0 E .
The Equation (37) will be solved by the Newton-type iterations:
J G ( y ( k ) ) y ( k + 1 ) = J G ( y ( k ) ) y ( k ) G ( y ( k ) ) , k = 0 , 1 , .
This iterative process generates a sequence { y ( k ) } starting from y ( 0 ) as an initial approximation. The right hand-side in (38) reads as follows:
J G ( y ( k ) ) y ( k ) G ( y ( k ) ) = b ( D ( I 0 ) D ( I 0 + ) ) g N 0 D κ + 1 ( D ( I + ) D ( I + + ) ) g N + 0 c .
From this it is easy to show that s n , I 0 + ( k + 1 ) = g I 0 + , s n , I 0 ( k + 1 ) = g I 0 and that the remaining components of the new iteration y ( k + 1 ) in (38) solve the following linear system:
A N A 0 T N N + T T T B T N A 0 0 0 0 0 N N + 0 D κ + 1 D ( I + + I + ) 0 0 T 0 0 0 0 B 0 0 0 E u ( k + 1 ) s n , A 0 ( k + 1 ) s n , N + ( k + 1 ) λ t ( k + 1 ) p ( k + 1 ) = b ˜ 0 g ˜ N + 0 c ,
where b ˜ = b N I 0 + T g I 0 + + N I 0 T g I 0 and g ˜ N + = D κ + 1 ( D ( I + ) D ( I + + ) ) g N + .
To solve the linear systems (39), we use the Schur complement S ( k ) to A -block defined by:
S ( k ) = F ( k ) + D ( k ) ,
where F ( k ) = C ( k ) A 1 ( C ( k ) ) T and D ( k ) = d i a g ( 0 , D κ + 1 D ( I + + I + ) , 0 , E ) with C ( k ) = ( N A 0 T , N N + T , T T , B T ) T . The right hand-sides of the Schur complement linear systems are given by
d ( k ) = C ( k ) A 1 b ˜ ( 0 T , g ˜ N + T , 0 T , c T ) T .
Note that the dependence on the k iteration is through the active set A 0 . We arrive at the implementation of (38), in which the iterations are performed only with the last four components of y assembled in the vector λ ^ = ( s n , N 0 T , s n , N + T , λ t T , p T ) T .
Algorithm SSN: Let λ ^ ( 0 ) d n s + n p , ε 0 , ρ > 0 , and set k : = 0 .
(i) 
Determine the inactive/active sets I 0 + , I 0 , A 0 , I + + , I + at λ ^ ( k ) to build S ( k ) and d ( k ) .
(ii) 
Set s n , I 0 + ( k + 1 ) = g I 0 + , s n , I 0 ( k + 1 ) = g I 0 and solve the Schur complement linear system
S ( k ) λ ˜ ( k + 1 ) = d ( k )
for the remaining components of λ ^ ( k + 1 ) assembled in the vector in λ ˜ ( k + 1 ) .
(iii) 
Return λ ^ ( k + 1 ) and u ( k + 1 ) = A 1 ( b ˜ C T λ ^ ( k + 1 ) ) with C = ( N N 0 T , N N + T , T T , B T ) T , if err ( k ) : = λ ^ ( k + 1 ) λ ^ ( k ) / λ ^ ( k + 1 ) ε , else set k : = k + 1 and go to step (i).
The algorithm is the dual variant of the semismooth Newton method with the superlinear convergence rate established in [39] provided that the initial iteration is sufficiently close to the solution. The overall computational efficiency depends on the way how the (inner) linear systems are solved. Although the size of S ( k ) depends on the cardinality of A 0 (i.e., on the k iteration), it is easily seen that these matrices are always positive definite. Hence, the linear systems (41) can be solved by the conjugate gradient method. This method in the k-th step of Algorithm SSN is initialized and terminated adaptively using the same ideas as in Algorithm PF. Note that the preconditioning of the conjugate gradient iterations is needed. This follows from the presence of D κ + 1 in D ( k ) and the fact that κ i , i N + , depend on the mesh norms (on the area of the respective triangles in (18) for d = 3 and the length of line segments in (19) for d = 2 ). Hence, c o n d ( S ( k ) ) tends to infinity, when the finite element mesh norm approaches zero. As S ( k ) is ill-conditioned through its diagonal, we use the diagonal preconditioner:
P ( k ) = D F ( k ) + D D ( k ) ,
where D F ( k ) = d i a g ( F ( k ) ) and D D ( k ) = d i a g ( 0 , D κ + 1 D ( I + + I + ) , 0 , d i a g ( E ) ) . From spectral analysis presented in [34], it follows that although S ( k ) and P ( k ) depend on κ i , i N + , the eigenvalue bounds of the preconditioned matrix ( P ( k ) ) 1 S ( k ) are positive and independent of κ i , i N + . Consequently,
cond ( ( P ( k ) ) 1 S ( k ) ) cond ( D F ( k ) ) cond ( F ( k ) ) .
In computations, we approximate D F ( k ) using analogous idea as in Algorithm PF.

5. Numerical Experiments

The computations were performed by the supercomputer Salomon at IT4I VŠB-TUO [40]. The Salomon cluster consists of 1009 compute nodes. Each node is a powerful x86-64 computer with Intel Xeon E5-2680v3 processors equipped with 24 cores and at least 128 GB RAM. All codes are implemented in Matlab R2020a. The velocity component is eliminated in both algorithms by solving auxiliary linear systems involving A κ or A with the preliminary Cholesky factorization realized by the Matlab function chol. We use Algorithm PF with c 1 = 10 3 , c 2 = 10 9 , c min = 10 12 , c max = 0.5 , c 3 = 10 2 , ε = 10 3 , r tol = 0.9 , c fact = 0.9 . These values turned out to be optimal, as it follows from the tests in [34]. Algorithm SSN uses r tol = 0.01 , c fact = 0.5 , and ε = 10 3 . The termination tolerance ε leads to the relative residua of order 10 5 . In the tables below the numbers n it , n F of the outer iterations, and the matrix-vector multiplications by F κ or F ( k ) , respectively, are monitored. Note that n F determines overall complexities of computations. The partitions T h of Ω are generated by Iso2mesh toolbox and ANSYS software [41,42]. As we have already mentioned, the finite element spaces use P1-bubble/P1 element pairs on T h . The resulting mesh will be characterized by values of the parameters n u , n p , n s introduced in Section 3. The stiffness matrices are assembled by the vectorized code [33,43]. To guarantee the uniqueness of the solution to (4) we will consider that Ω is decomposed into three non-overlapping and non-empty parts Γ , S, and Γ N open in Ω (see Remark 2). Nevertheless, one example and comments when Γ N = will be presented, as well. Finally note that all physical quantities are considered in the SI system so that the units of g and κ are Pa and Pa . s . m 1 , respectively.
Example 1.
(Square in 2D). Let Ω = ( 0 , 1 ) 2 . To construct the triangulation T h we first cut Ω into small squares and then each square into two triangles, see Figure 1(left). The decomposition of Ω is defined as follows: Γ = ( 0 , 1 ) × { 1 } , Γ N = γ left γ right , S = ( 0 , 1 ) × { 0 } , where γ left = { 0 } × ( 0 , 1 ) , γ right = { 1 } × ( 0 , 1 ) . Further f = 2 μ d i v 𝔻 ( u exp ) + p exp in Ω , μ = 1 / 2 , u = 0 on Γ , σ N = 2 μ 𝔻 ( u exp ) n p exp n on Γ N , g = 15 , and κ = 30 on S (see Remark 5), where u exp = ( u exp , 1 , u exp , 2 ) , and
u exp , 1 ( x , y ) = ( 1 cos ( 2 π x ) ) sin ( 2 π y ) , u exp , 2 ( x , y ) = sin ( 2 π x ) ( cos ( 2 π y ) 1 ) , p exp ( x , y ) = 2 π ( cos ( 2 π x ) + 2 cos ( 2 π y ) + 1 ) .
Note that u exp satisfies the homogeneous Dirichlet boundary condition on Ω . Data are chosen in such a way that both, leak and no leak zones appear on S. Figure 1 (right) presents the streamlines of the computed solution. One can see that the leak on S generates the fluid suction on Γ N . Figure 2 shows the pressure and velocity distribution in Ω . The magnitudes of the normal velocity | u n | and of the normal stress | σ n | on S are seen in Figure 3 (left), while | σ ˜ n | is depicted in Figure 3 (right). In the tables below the values n it , n F , and CPU time (in seconds) for different finite element meshes with increasing n u , n p , and n s , and different values of g are compared. The computational complexities for g = 15 are shown in Table 1. The analogous characteristics for g = 0.1 (leak everywhere) and g = 100 (no leak) are summarized in Table 2 and Table 3, respectively. In view of the values of n F , one can see that both algorithms are scalable. The computations without preconditioning are considerably less efficient as it is seen from Table 4.
Example 2.
(Cube in 3D). Let Ω = ( 0 , 1 ) 3 . To construct the partition T h we first cut Ω into small cubes and then each cube is split into five tetrahedras, see Figure 4. The partition of Ω into Γ , S, and Γ N is defined as follows: Γ = γ top γ bottom γ back , Γ N = γ left γ right , S = γ front , where γ bottom = ( 0 , 1 ) × ( 0 , 1 ) × { 0 } , γ top = ( 0 , 1 ) × ( 0 , 1 ) × { 1 } , γ back = { 1 } × ( 0 , 1 ) × ( 0 , 1 ) , γ left = ( 0 , 1 ) × { 0 } × ( 0 , 1 ) , γ right = ( 0 , 1 ) × { 1 } × ( 0 , 1 ) , γ front = { 0 } × ( 0 , 1 ) × ( 0 , 1 ) . Further f = 2 μ d i v 𝔻 ( u exp ) + p exp in Ω , μ = 1 / 2 , u = 0 on Γ , σ N = 2 μ 𝔻 ( u exp ) n p exp n on Γ N , g = 15 , and κ = 30 , where u exp = ( u exp , 1 , u exp , 2 , u exp , 3 ) , and
u exp , 1 ( x , y , z ) = 4 ( 1 cos ( 2 π x ) ) sin ( 2 π y ) z ( 1 z ) , u exp , 2 ( x , y , z ) = 4 sin ( 2 π x ) ( cos ( 2 π y ) 1 ) z ( 1 z ) , u exp , 3 ( x , y , z ) = 0 , p exp ( x , y , z ) = 2 π ( cos ( 2 π x ) + 2 cos ( 2 π y ) cos ( 2 π z ) ) .
Again, u exp satisfies the homogeneous Dirichlet boundary condition on Ω and data are chosen in such a way that both, leak and no leak zones appear on S. Figure 5 shows the distribution of the velocity field on S and Γ N . One can see the leak zone in the middle of S and the fluid suction on γ left . The same suction effect appears on γ right . The normal stress | σ n | and | σ ˜ n | on S are seen in Figure 6. In Table 5, Table 6, Table 7 and Table 8 we summarize analogous characteristics as in Example 1. The conclusions are also analogous, i.e., both algorithms turn out to be scalable also in 3D and the preconditioner plays an important role. Notice that the numbers n F of the matrix-vector multiplications are lower compared to 2D case.
Example 3.
(Cube in 3D, non-unique solution). We change the partition of Ω from Example 2 as follows: Γ N = , Γ = γ left γ right γ back γ front γ top , and S = γ bottom . Let us remind that, if Γ N = , the pressure might be non-unique depending on the choice of g. Next we suppose that g is constant and κ = 0 on S. To establish the critical value of g we use the Stokes system with the homogeneous Dirichlet data prescribed on the whole boundary Ω . Assuming that its solution is smooth enough, g crit = ( sup S ( σ n ) inf S ( σ n ) ) / 2 , where σ n is the corresponding normal stress. However since the whole procedure is applied to the finite element discretization, the regularity assumption is superfluous. For given physical data and the partition T h characterized by the parameters n u / n p / n s = 38 , 088 / 15 , 625 / 529 the value g crit = 18.31 . It is easy to show that if g < g crit , the problem has a unique solution with both, leak and no-leak zones on S. If g > g crit , the solution is not unique and only no-leak zone appears on S. The behavior of the algorithms for different g is summarized in Table 9. One can see that both algorithms are stable in all cases. The table presents also the values sup S ( σ n g ) and inf S ( σ n g ) computed for the respective g. One can easily check that ( sup S ( σ n g ) inf S ( σ n g ) ) / 2 = g crit for g g crit , while ( sup S ( σ n g ) inf S ( σ n g ) ) / 2 = g if g < g crit . The distribution of the velocity field on S for g = 16.31 is seen from Figure 7. Note that the matrix C used in (25), especially its part ( N T , B T ) T , has not the full row-rank due to Γ N = . Consequently, F κ and F ( k ) for A 0 = N 0 are singular with the defect one and the eigenvector whose all components are equal to 1 corresponds to the zero eigenvalue. The matrix S κ ( k ) of the inner linear systems in Algorithm PF is regularized by adding the diagonal matrix J 12 M ( k ) ( Z ( k ) ) 1 J 12 T to F κ as seen from (31) (there are non-zero diagonal entries on the level of N ). Analogously, the matrix S ( k ) in Algorithm SSN is regularized by adding D ( k ) to F ( k ) (see (41)) and by the choice of the active set A 0 N 0 . These heuristic arguments show that the matrices of the solved linear systems can be regularized by the construction of the algorithms. Finally note that the condition number bounds of the preconditioned Schur complements (32) and (42) are no longer valid. Nevertheless, the preconditioners can still be used and play the same important role as in the previous examples.
Example 4.
(3D branched tube). Let Ω be the branched tube as in Figure 8, where the partition T h and the partition of the boundary Ω = S ¯ γ in ¯ γ out 1 ¯ γ out 2 ¯ is also depicted. This tube may represent a final part of the capillary in the human body. On Γ = γ in we prescribe the input velocity u | Γ , 1 = a a / r 2 ( y 2 + z 2 ) , u | Γ , 2 = u | Γ , 3 = 0 with a = 5 · 10 4 , r = 5.94 · 10 4 while Γ N = γ out 1 γ out 2 consists of two outputs of the tube with the natural outflow condition σ N = 0 . The leak condition is prescribed on S = Ω Γ Γ N ¯ . Further f = 0 in Ω , μ = 1 / 2 , and κ = 30 . The partition T h is characterized by the following values of the parameters: n u = 27 , 408 , n p = 9178 , and n s = 4079 . The behavior of Algorithm PF and Algorithm SSN for different g is reported in Table 10. The distribution of the velocity and the pressure for three selected g is depicted in Figure 9. Almost all liquid leak through the wall at the vicinity of γ in for the smallest value g = 10 can be observed, see Figure 9 (top). The leak through the wall is minimal for g = 50 , see Figure 9 (bottom). The pressure is also growing for higher values of g. The zoomed parts of the velocity fields near γ in and γ out 2 are depicted in Figure 10 (the velocity distribution inside the tube looks like the Poiseuille distribution). We used the reorthogonalization technique of the descent vectors inside the CGM solver [44] that increases considerably efficiency of computations; compare Table 10 with Table 11.

6. Conclusions and Comments

We have proposed two algorithms for solving the Stokes flow with the threshold leak boundary condition, both based on dual strategies. Unlike the threshold slip boundary conditions [28], the algorithms are identical in 2D and 3D. Algorithm PF is based on the path-following variant of the interior point method that generates strictly feasible iterations. This algorithm combines the dumped Newton method in the outer loop with the preconditioned conjugate gradient method used for solving the inner linear systems. The precision control of the inner loop is driven adaptively with respect to the accuracy achieved in the outer level. The crucial ingredient of the algorithm is its diagonal preconditioner that improves ill-conditioning of the system matrices in the later iterations of the outer loop. Algorithm SSN uses the active-set implementation of the semi-smooth Newton method adapted for our type of boundary conditions. The inner linear systems are solved using the same ideas as in Algorithm PF. In this case, the diagonal preconditioner improves ill-conditioning caused by small finite element mesh norms. Experimental scalability of both algorithms is indicated by numerical experiments. Indeed, one can conclude that Algorithm SSN is more efficient than Algorithm PF. Problems with multiple solutions can be also solved since the singular dual Hessian is implicitly regularized by the construction of the algorithms.

Author Contributions

Conceptualization, J.H. and R.K.; methodology, J.H. and R.K.; software, K.M. and V.Š.; validation, J.H., R.K., K.M. and V.Š.; formal analysis, J.H. and R.K.; investigation, J.H., R.K., K.M. and V.Š.; resources, J.H. and R.K.; data curation, J.H.; writing—original draft preparation, J.H. and R.K.; writing—review and editing, R.K., K.M. and V.Š.; visualization, K.M. and V.Š.; supervision, J.H. and R.K.; project administration, K.M.; funding acquisition, R.K. and V.Š. All authors have read and agreed to the published version of the manuscript.

Funding

This work was supported by the Ministry of Education, Youth and Sports of the Czech Republic through the e-INFRA CZ (ID:90140). The paper also includes the results of the internal BUT FIT project FIT-S-20-6427 (VS). The first author acknowledges the support of FW01010096 of the Czech Technological Agency.

Conflicts of Interest

The authors declare no conflict of interest. The funders had no role in the design of the study; in the collection, analyses, or interpretation of data; in the writing of the manuscript, or in the decision to publish the results.

References

  1. Navier, C.L. Mémoires sur les lois du mouvement des fluids. Mem. Acad. R. Paris 1823, 6, 389–416. [Google Scholar]
  2. Ekeland, I.; Temam, R. Analyse Convex et Problèmes Variationnels; Dunod, Gauthier-Villars: Paris, France, 1974. [Google Scholar]
  3. Rao, J.; Rajagopal, K. The effect of the slip boundary conditions on the flow of fluids in a channel. Acta Mech. 1999, 135, 113–126. [Google Scholar] [CrossRef]
  4. Fujita, H. A coherent analysis of Stokes flows under boundary conditions of friction type. J. Comput. Appl. Math. 2002, 149, 57–69. [Google Scholar] [CrossRef] [Green Version]
  5. Fujita, H. A mathematical analysis of motions of viscous incompressible fluid under leak and slip boundary conditions. RIMS Kokyuroku 1994, 888, 199–216. [Google Scholar]
  6. Roux, C.L. Steady Stokes flows with Threshold Slip Boundary Conditions. Math. Models Meth. Appl. Sci. 2005, 15, 1141–1168. [Google Scholar] [CrossRef]
  7. Roux, C.L.; Tani, A. Steady solutions of the Navier-Stokes equations with Threshold Slip Boundary Conditions. Math. Meth. Appl. Sci. 2007, 30, 595–624. [Google Scholar] [CrossRef]
  8. Saito, N. On the Stokes Equation with the Leak and Slip Boundary conditions of Friction type: Regularity of Solutions. Publ. RIMS Kyoto Univ. 2004, 40, 345–383. [Google Scholar] [CrossRef] [Green Version]
  9. Consiglieri, L. A non-local Friction Problem for a class of Non-Newtonian Flows. Porth. Math. 2003, 60, 237–251. [Google Scholar]
  10. Boukrouche, M.; Paoli, L. Global existence for a 3D non-stationary Stokes flow with Coulomb’s type friction boundary conditions. Appl. Anal. 2017, 1–31. [Google Scholar] [CrossRef]
  11. Balilescu, L.; Martín, J.S.; Takahashi, T. On the Navier-Stokes system with the Coulomb friction law boundary condition. Math. Phys. 2017, 68, 1–25. [Google Scholar] [CrossRef] [Green Version]
  12. Haslinger, J.; Hlaváček, I.; Nečas, J. Numerical methods for unilateral problems in solid mechanics. Handb. Numer. Anal. IV North-Holl. 1996. [Google Scholar] [CrossRef]
  13. Saito, N.; Sugitani, Y.; Zhou, G. Unilateral problem for the Stokes equations: The well-posedness and finite element approximation. Appl. Num. Math. 2016, 105, 124–147. [Google Scholar] [CrossRef] [Green Version]
  14. Zhou, G.; Saito, N. The Navier-Stokes equations under a unilateral boundary condition of Signorini’s type. Math. Fluid Mech. 2016, 18, 481–510. [Google Scholar] [CrossRef]
  15. Glowinski, R. Numerical Methods for Nonlinear Variational Problems; Springer Series in Computational Physics; Springer: Berlin, Germany, 1983. [Google Scholar] [CrossRef]
  16. Fortin, M.; Glowinski, R. Augmented Lagrangian Methods: Applications to the Numerical Solution of Boundary Value Problems. In Studies in Mathematics and Its Applications; Elsevier: North-Holland, The Netherlands, 1983; Volume 15. [Google Scholar] [CrossRef]
  17. Girault, V.; Raviart, P.A. Finite Element Methods for Navier-Stokes Equations, Theory and Algorithms; Springer: Berlin, Germany, 1986. [Google Scholar] [CrossRef]
  18. Brezzi, F.; Fortin, M. Mixed and Hybrid Finite Element Methods; Springer Series in Computational Mathematics; Springer: Berlin/Heidelberg, Germany, 1991; Volume 15. [Google Scholar] [CrossRef] [Green Version]
  19. Haslinger, J.; Mäkinen, R.A.E. The parameter identification in the Stokes system with threshold slip boundary conditions. ZAMM 2020, 100, 5. [Google Scholar] [CrossRef]
  20. Ayadi, M.; Gdoura, M.K.; Sasssi, T. Error estimates for Stokes problem with Tresca friction conditions. ESAIM Math. Model. Numer. Anal. 2014, 48, 1413–1429. [Google Scholar] [CrossRef] [Green Version]
  21. Kashiwabara, T. On a finite element approximation of the Stokes equations under a slip boundary condition of the friction type. Jpn. J. Industr. Appl. Math. 2013, 30, 227–261. [Google Scholar] [CrossRef]
  22. Kashiwabara, T. Finite element method for the Stokes equations under a leak boundary condition of friction type. SIAM J. Numer. Anal. 2013, 51, 2448–2469. [Google Scholar] [CrossRef]
  23. Djoko, J.K.; Mbehou, M. Finite element analysis for Stokes and Navier Stokes equations driven by threshold slip boundary conditions. Int. J. Numer. Anal. Model. 2013, B4, 235–255. [Google Scholar]
  24. Haslinger, J.; Kučera, R.; Šátek, V. Stokes system with local Coulomb’s boundary conditions: Analysis of discretized models and Implementation. Comp. Math. Appl. 2019, 77, 1655–1667. [Google Scholar] [CrossRef]
  25. Djoko, J.K.; Koko, J. Numerical methods for the Stokes and Navier-Stokes equations driven by slip boundary conditions. Comput. Methods Appl. Mech. Engrg. 2016, 305, 936–958. [Google Scholar] [CrossRef] [Green Version]
  26. Djoko, J.K.; Koko, J.; Kučera, R. Power law Stokes equations with threshold slip boundary conditions: Numerical methods and implementation. Math. Methods Appl. Sci. 2019, 42, 1488–1511. [Google Scholar] [CrossRef] [Green Version]
  27. Kučera, R.; Haslinger, J.; Šátek, V.; Jarošová, M. Efficient methods for solving the Stokes problem with slip boundary conditions. Math. Comput. Simul. 2018, 145, 114–124. [Google Scholar] [CrossRef]
  28. Haslinger, J.; Kučera, R.; Sassi, T.; Šátek, V. Dual strategies for solving the Stokes problem with stick-slip boundary conditions in 3D. Math. Comput. Simul. 2021, 189, 191–206. [Google Scholar] [CrossRef]
  29. Kučera, R. Convergence rate of an optimization algorithm for minimizing quadratic functions with separable convex constraints. SIAM J. Optim. 2008, 19, 846–862. [Google Scholar] [CrossRef]
  30. Brzobohatý, T.; Jarošová, M.; Kučera, R.; Šátek, V. Path-following interior point method: Theory and applications for the Stokes flow with a stick-slip boundary condition. Adv. Eng. Softw. 2019, 129, 35–43. [Google Scholar] [CrossRef]
  31. Haslinger, J.; Stebel, J. Stokes problem with a solution dependent slip bound: Stability of solutions with respect to domains. ZAMM—J. Appl. Math. Mech./Z. Angew. Math. Mech. 2016, 96, 1049–1060. [Google Scholar] [CrossRef] [Green Version]
  32. Arnold, D.N.; Brezzi, F.; Fortin, M. A stable finite element for the Stokes Equations. Calcolo 1984, 21, 337–344. [Google Scholar] [CrossRef]
  33. Koko, J. Efficient MATLAB codes for the 2D/3D Stokes equation with the mini-element. Informatica 2019, 30, 243–268. [Google Scholar] [CrossRef] [Green Version]
  34. Kučera, R.; Machalová, J.; Netuka, H.; Ženčák, P. An interior point algorithm for the minimization arising from 3D contact problems with friction. Optim. Methods Softw. 2013, 28, 1195–1217. [Google Scholar] [CrossRef] [Green Version]
  35. Kučera, R.; Motyčková, K.; Markopoulos, A. The R-linear convergence rate of an algorithm arising from the semi-smooth Newton method applied to 2D contact problems with friction. Comput. Optim. Appl. 2015, 61, 437–461. [Google Scholar] [CrossRef]
  36. Kučera, R.; Motyčková, K.; Markopoulos, A.; Haslinger, J. On the inexact symmetrized globally convergent semi-smooth Newton method for 3D contact problems with Tresca friction: The R-linear convergence rate. Optim. Methods Softw. 2020, 35, 65–86. [Google Scholar] [CrossRef]
  37. Kučera, R.; Motyčková, K.; Pacholek, J.; Sassi, T. The semi-smooth Newton method for solving the Stokes problem with the stick-slip boundary Condition. AIP Conf. Proc. 2018, 1978, 360003. [Google Scholar] [CrossRef]
  38. Nocedal, J.; Wächter, A.; Waltz, R.A. Adaptive barrier update strategies for nonlinear interior methods. SIAM J. Optim. 2009, 19, 1674–1693. [Google Scholar] [CrossRef] [Green Version]
  39. Hintermüller, M.; Ito, K.; Kunisch, K. The primal-dual active set strategy as a semismooth Newton method. SIAM J. Optim. 2002, 13, 865–888. [Google Scholar] [CrossRef] [Green Version]
  40. Salomon Hardware Overview. Available online: https://docs.it4i.cz/salomon/hardware-overview/ (accessed on 1 October 2021).
  41. Iso2mesh: A 3D Surface and Volumetric Mesh Generator for MATLAB/Octave. Available online: http://iso2mesh.sourceforge.net (accessed on 13 October 2021).
  42. Ansys: Engineering Simulation Software. Available online: https://www.ansys.com/ (accessed on 16 September 2021).
  43. Arzt, V. Finite Element Meshes and Assembling of Stiffness Matrices. Master’s Thesis, VŠB-TU Ostrava, Ostrava, Czech Republic, 2019. [Google Scholar]
  44. Kamath, C. The FETI Level 1 Method: Theory and Implementation; Technical Report UCRL-ID-138075; Lawrence Livermore National Laboratory: Livermore, CA, USA, 2000; pp. 1–31. [Google Scholar] [CrossRef] [Green Version]
Figure 1. Two-dimensional (2D) mesh (left) and streamlines (right); g = 15 , κ = 30 .
Figure 1. Two-dimensional (2D) mesh (left) and streamlines (right); g = 15 , κ = 30 .
Mathematics 09 02906 g001
Figure 2. The pressure (left) and velocity (right) distribution; g = 15 , κ = 30 .
Figure 2. The pressure (left) and velocity (right) distribution; g = 15 , κ = 30 .
Mathematics 09 02906 g002
Figure 3. Distribution of | u n | , | σ n | (left) and | σ ˜ n | (right) on S; g = 15 , κ = 30 .
Figure 3. Distribution of | u n | , | σ n | (left) and | σ ˜ n | (right) on S; g = 15 , κ = 30 .
Mathematics 09 02906 g003
Figure 4. Splitting of the small cube (left) and 3D mesh (right); 1728 cubes and 8640 tetrahedras.
Figure 4. Splitting of the small cube (left) and 3D mesh (right); 1728 cubes and 8640 tetrahedras.
Mathematics 09 02906 g004
Figure 5. Velocity field on S and Γ N ; g = 15 , κ = 30 .
Figure 5. Velocity field on S and Γ N ; g = 15 , κ = 30 .
Mathematics 09 02906 g005
Figure 6. Distribution of | σ n | (left) and | σ ˜ n | (right) on S; g = 15 , κ = 30 .
Figure 6. Distribution of | σ n | (left) and | σ ˜ n | (right) on S; g = 15 , κ = 30 .
Mathematics 09 02906 g006
Figure 7. Distribution of the velocity field on S for g = 16.31 , κ = 0 , and Γ N = ; the whole cube (left) and S (right).
Figure 7. Distribution of the velocity field on S for g = 16.31 , κ = 0 , and Γ N = ; the whole cube (left) and S (right).
Mathematics 09 02906 g007
Figure 8. Branched tube: mesh.
Figure 8. Branched tube: mesh.
Mathematics 09 02906 g008
Figure 9. Distribution of the velocity (left) and the pressure (right) for g = 10 , 30 , 50 .
Figure 9. Distribution of the velocity (left) and the pressure (right) for g = 10 , 30 , 50 .
Mathematics 09 02906 g009
Figure 10. Distribution of the velocity near γ i n (left) and γ out 2 (right) for g = 10 , 30 , 50 .
Figure 10. Distribution of the velocity near γ i n (left) and γ out 2 (right) for g = 10 , 30 , 50 .
Mathematics 09 02906 g010
Table 1. Computations with preconditioner for g = 15 , κ = 30 .
Table 1. Computations with preconditioner for g = 15 , κ = 30 .
Algorithm PFAlgorithm SSN
n u / n p / n s time(s.) n it / n F time(s.) n it / n F
8320/4225/651.212/1710.76/97
18,624/9409/973.712/1942.88/139
33,024/16,641/1298.412/2094.87/129
51,520/25,921/16115.512/23110.28/150
74,112/37,249/19323.812/22815.77/139
100,800/50,625/22542.412/26025.57/147
131,584/66,049/25762.412/26638.57/147
166,464/83,521/28982.912/25158.37/156
205,440/103,041/321118.012/26178.37/153
248,512/124,609/353172.013/295110.07/164
Table 2. Computations with preconditioner for g = 0.1 , κ = 30 .
Table 2. Computations with preconditioner for g = 0.1 , κ = 30 .
Algorithm PFAlgorithm SSN
n u / n p / n s time(s.) n it / n F time(s.) n it / n F
8320/4225/651.110/1310.86/88
18,624/9409/973.011/1442.36/97
33,024/16,641/1296.412/1783.76/100
51,520/25,921/16112.012/1818.37/120
74,112/37,249/19316.610/16416.17/131
100,800/50,625/22532.012/19018.55/89
131,584/66,049/25748.712/19635.37/137
166,464/83,521/28976.113/22150.47/134
205,440/103,041/321110.514/23772.57/142
248,512/124,609/353128.012/21199.87/147
Table 3. Computations with preconditioner for g = 100 , κ = 30 .
Table 3. Computations with preconditioner for g = 100 , κ = 30 .
Algorithm PFAlgorithm SSN
n u / n p / n s time(s.) n it / n F time(s.) n it / n F
8320/4225/651.29/1500.86/87
18,624/9409/973.99/1902.17/116
33,024/16,641/12912.611/2946.68/142
51,520/25,921/16115.411/2758.16/102
74,112/37,249/19328.210/24420.29/172
100,800/50,625/22542.710/25124.57/134
131,584/66,049/25761.410/25826.25/88
166,464/83,521/28986.810/26354.77/143
205,440/103,041/321121.610/27185.38/168
248,512/124,609/353164.810/28195.17/139
Table 4. Computations without preconditioner for g = 15 , κ = 30 .
Table 4. Computations without preconditioner for g = 15 , κ = 30 .
Algorithm PFAlgorithm SSN
n u / n p / n s time(s.) n it / n F time(s.) n it / n F
8320/4225/6513.027/15549.113/1450
18,624/9409/9736.331/186530.820/2036
33,024/16,641/129103.033/248482.020/2352
51,520/25,921/161239.639/3371188.515/3164
74,112/37,249/193459.842/4089343.614/3672
Table 5. Computations with preconditioner for g = 15 , κ = 30 .
Table 5. Computations with preconditioner for g = 15 , κ = 30 .
Algorithm PFAlgorithm SSN
n u / n p / n s time(s.) n it / n F time(s.) n it / n F
5148/2197/1430.911/1000.46/67
12,240/4913/2553.211/1071.36/66
23,940/9261/39912.511/1206.36/77
41,400/15,625/57531.311/12816.26/79
65,772/24,389/78373.711/14034.76/77
98,208/35,937/1023136.811/13768.56/77
139,860/50,653/1295280.812/155124.06/77
191,880/68,921/1599502.912/162235.66/83
Table 6. Computations with preconditioner for g = 0.1 , κ = 30 .
Table 6. Computations with preconditioner for g = 0.1 , κ = 30 .
Algorithm PFAlgorithm SSN
n u / n p / n s time(s.) n it / n F time(s.) n it / n F
5148/2197/1430.811/870.46/66
12,240/4913/2553.913/951.77/76
23,940/9261/3999.811/905.76/72
41,400/15,625/57526.513/10112.96/64
65,772/24,389/78355.711/10123.95/54
98,208/35,937/1023137.015/12745.85/54
139,860/50,653/1295246.114/12682.75/55
191,880/68,921/1599400.613/119145.55/56
Table 7. Computations with preconditioner for g = 100 , κ = 30 .
Table 7. Computations with preconditioner for g = 100 , κ = 30 .
Algorithm PFAlgorithm SSN
n u / n p / n s time(s.) n it / n F time(s.) n it / n F
5148/2197/1431.08/920.46/71
12,240/4913/2553.78/9927/77
23,940/9261/39912.58/1346.26/76
41,400/15,625/57533.68/13816.16/77
65,772/24,389/78357.77/11634.56/76
98,208/35,937/1023139.08/14168.76/77
139,860/50,653/1295249.78/1451407/92
191,880/68,921/1599400.78/133166.94/64
Table 8. Computations without preconditioner for g = 15 , κ = 30 .
Table 8. Computations without preconditioner for g = 15 , κ = 30 .
Algorithm PFAlgorithm SSN
n u / n p / n s time(s.) n it / n F time(s.) n it / n F
5148/2197/ 14321.741/296314.09/1940
12,240/4913/25586.532/270040.69/2198
23,940/9261/399688.759/7857273.710/3281
41,400/15,625/5751549.646/6909796.510/3673
Table 9. Computations with different g and κ = 0 for Γ N = ( n u / n p / n s = 38 , 088 / 15 , 625 / 529 ).
Table 9. Computations with different g and κ = 0 for Γ N = ( n u / n p / n s = 38 , 088 / 15 , 625 / 529 ).
Algorithm PFAlgorithm SSN
g inf S ( σ n g ) / sup S ( σ n g ) time(s.) n it / n F time(s.) n it / n F
g crit + 2 19.86 / 16.76 106.118/61532.37/192
g crit + 0.5 18.60 / 18.02 104.920/58139.78/232
g crit + 0.2 18.40 / 18.22 113.921/66239.18/234
g crit 18.31 / 18.31 118.721/68238.58/231
g crit 0.2 18.11 / 18.11 105.821/61940.38/234
g crit 0.5 17.81 / 17.81 83.518/46234.38/201
g crit 2 16.31 / 16.31 53.915/18924.47/156
Table 10. Computations for different values of g with reorthogonalization.
Table 10. Computations for different values of g with reorthogonalization.
Algorithm PFAlgorithm SSN
g time(s.) n it / n F time(s.) n it / n F
10301826/3511136915/1882
20312226/3805134815/1885
30314625/3934137015/1882
40362226/4291109613/1522
50394826/450899512/1377
Table 11. Computations for different values of g without reorthogonalization.
Table 11. Computations for different values of g without reorthogonalization.
Algorithm PFAlgorithm SSN
g time(s.) n it / n F time(s.) n it / n F
10831425/11,01715,58415/21,214
20992725/12,59414,93414/21,344
3010,86625/13,86111,15614/16,653
4010,81526/15,52011,69612/16,473
5012,80126/16,62218,6739/24,300
Publisher’s Note: MDPI stays neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Share and Cite

MDPI and ACS Style

Haslinger, J.; Kučera, R.; Motyčková, K.; Šátek, V. Numerical Modeling of the Leak through Semipermeable Walls for 2D/3D Stokes Flow: Experimental Scalability of Dual Algorithms. Mathematics 2021, 9, 2906. https://doi.org/10.3390/math9222906

AMA Style

Haslinger J, Kučera R, Motyčková K, Šátek V. Numerical Modeling of the Leak through Semipermeable Walls for 2D/3D Stokes Flow: Experimental Scalability of Dual Algorithms. Mathematics. 2021; 9(22):2906. https://doi.org/10.3390/math9222906

Chicago/Turabian Style

Haslinger, Jaroslav, Radek Kučera, Kristina Motyčková, and Václav Šátek. 2021. "Numerical Modeling of the Leak through Semipermeable Walls for 2D/3D Stokes Flow: Experimental Scalability of Dual Algorithms" Mathematics 9, no. 22: 2906. https://doi.org/10.3390/math9222906

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