Home A dimension expanded preconditioning technique for block two-by-two linear equations
Article Open Access

A dimension expanded preconditioning technique for block two-by-two linear equations

  • Wei-Hua Luo EMAIL logo , Bruno Carpentieri and Jun Guo
Published/Copyright: October 31, 2023
Become an author with De Gruyter Brill

Abstract

In this article, we introduce a novel block preconditioner for block two-by-two linear equations by expanding the dimension of the coefficient matrix. Theoretical results on the eigenvalues distribution of the preconditioned matrix are obtained, and a feasible implementation is discussed. Some numerical examples, including the solution of the Navier-Stokes equations, are presented to support the theoretical findings and demonstrate the preconditioner’s efficiency.

MSC 2010: 65F08; 65F10

1 Introduction

In this article, we focus on solving the block two-by-two system of linear equations of the form

(1.1) A B C D x 1 x 2 = b 1 b 2 ,

where A R m × m , B R m × n , C R n × m , and D R n × n are sparse matrices with m n , A is nonsingular, x 1 , b 1 R m × 1 , x 2 , b 2 R n × 1 . Many engineering problems are discretized into linear systems of form (1.1) using numerical methods such as finite difference methods (FDMs), finite element methods (FEMs), and spectral methods. Using FEMs to solve the Navier-Stokes equations, for instance, yields (1.1), where A and D are symmetric positive definite (SPD) and symmetric positive semi-definite (SPSD), respectively, and C = B T [1,2]. The discretization of some electromagnetic scattering and quantum mechanics problems [3,4] results in a complex symmetric indefinite linear system

(1.2) ( W + i T ) x = b , i = 1 , W , T R n × n , x , b C n ,

which can be transformed into a special case of (1.1) (see [5,6]), namely,

(1.3) T W W T x y = g f b .

Further examples of (1.1) with B ± C T and B ± C can be found in the fields of Economics, Computational Fluid Dynamics, and so on. Table 1 contains some examples taken from the University of Florida Sparse Matrix Collection (URL: https://sparse.tamu.edu/, see, [7,8]).

Table 1

Features of matrices in Example 3

Name Background m n nnz Condition number
dw256A Electromagnetics problem 400 112 2,480 3.7165 × 1 0 4
ck656 2D/3D problem 500 156 3,884 1.1802 × 1 0 7
poli Economic problem 3,000 1,008 8,188 6.3993 × 1 0 1
p o l i l a r g e Economic problem 13,575 2,000 33,033 48.0022
venkat25 Computational fluid dynamics problem 40,000 22,424 1,717,763 1.2165 × 1 0 8
poisson3Db Computational fluid dynamics problem 45,000 40,623 2,374,949 1.6555 × 1 0 5

When m and n are large enough, researchers are more likely to adopt iterative approaches to solve (1.1), since they can alleviate the high memory and computing costs of direct methods, assuming some effective preconditioners are available to lower the number of iterations. For some special cases of problem (1.1), many excellent preconditioning techniques have been proposed so far. For example, Benzi and Golub [9] presented a Hermitian and skew-Hermitian splitting (HSS) preconditioner based on the Hermitian and skew-Hermitian splitting iterative method for the case of SPD A , SPSD D , and C = ± B T (also known as a generalized saddle point problem). Bai and Cao et al. [10,11] investigated a simplified HSS preconditioner (SHSS) that approximates the coefficient matrix more closely than HSS. Also, Cao et al. [12,13] successively presented a modified dimensional split (MDS) preconditioner and relaxed splitting preconditioner, which can be seen as excellent generalizations of the preconditioners from [14,15]. Especially, in [12] a complete convergence theorem of the corresponding MDS stationary iteration method was proved. Zhang [16] presented an efficient variant of HSS (EVHSS) preconditioner by combining it with the relaxation preconditioning technique. Other strategies can be found in [17,18] for constraint preconditioners, [19] for splitting preconditioner, [20] for incomplete LU (ILU) preconditioner, and so on. Zhang and Dai [5,21] and Shen and Shi [22] designed a block preconditioner, a splitting preconditioner, and a variant HSS preconditioner for cases (1.2) or (1.3). Many more results about preconditioning methods have been explored for the case of D = 0 , B = ± C T (called a saddle problem), including but not limited to dimensional split (DS) [14], relaxed dimensional factorization [15], relaxed physical factorization [23], dimension-wise splitting iteration with selective relaxation [24], HSS-types [9,25], and the references therein. Bai [26] studied a class of structured preconditioners through matrix transformation and matrix approximations for the general case (1.1). Other methods include product (PS) preconditioner [27], alternating splitting preconditioner [28,29], extended positive-definite and skew-Hermitian splitting (EPSS) preconditioner [30], block positive semi-definite splitting (BPS) preconditioner [31], and so on.

It is not difficult to find that almost all of the aforementioned results require the solution of a subproblem that includes at least a Schur complement structure. In [11,16,21], for example,

(1.4) α I B T B C u 1 u 2 = v 1 v 2 , A B T B α I u 1 u 2 = v 1 v 2 , α I W W T u 1 u 2 = v 1 v 2

need to be computed, respectively. In [26,27], the subsystems

(1.5) ( I C ¯ B ¯ ) u ¯ = v ¯ , ( D C G 1 B ) u ¯ = v ¯

should be dealt with, respectively, where G is an approximation of A , and

B ¯ = L A 1 B R D 1 , C ¯ = L D 1 C R A 1 ,

where L A , R A , L D , and R D satisfy

A = L A J A R A , D = L D J D R D ,

with J A and J D two matrices approximating the identity matrices of R m × m and R n × n , respectively. Solving the systems (1.4) or (1.5) may be costly in terms of computer memory and CPU time when the density of B and C is relatively high and m and n are sufficiently large.

In this article, we present a novel preconditioner inspired by the idea of [32]. The key idea of this technique is to expand the dimension of the coefficient matrix and transform it into an augmented equivalent system. Implementing this dimension expanding (DE) preconditioner saves us the trouble of solving the aforementioned subproblems that are similar to (1.4) or (1.5); instead, we only need to solve the subsystems

(1.6) A u 1 = v 1 , [ ( 1 α ) I α D ] u 2 = v 2 .

The rest of this article is structured as follows. Section 2 describes in detail the novel preconditioner and discusses its practical implementation. The eigenvalue distributions of the preconditioned matrix is theoretically examined. Later, in Section 3, some practical numerical examples, including the Navier-Stokes equations, are provided to demonstrate the efficiency of the novel preconditioner when compared to other existing techniques. Finally, Section 4 draws conclusions.

2 Description of the dimension expanded preconditioner (shortly, P DE )

To begin, we transform (1.1) into an equivalent system of the form

(2.1) B ˜ A ˜ D C x 2 x 1 = b ˜ 1 b 2 , A ˜ = A + B C , B ˜ = B + B D , b ˜ 1 = b 1 + B b 2 .

Second, we augment (2.1) into a 3 × 3 block system of the form

(2.2) H u = I 0 I α 1 B + B D A + B C ( α 1 1 ) B I + D C I x 2 x 1 x 3 = 0 b ˜ 1 b 2

by taking α 1 = α 2 2 α 2 1 , where α 2 is a chosen parameter close to 1.

It is worth noting here that the goal of performing an equivalent transformation from (1.1) into (2.1) and augmenting (2.1) into (2.2) is only to obtain the following preconditioner (abbreviated as P DE ), for which we will see that solving P DE u = v can be easily and cheaply implemented.

The preconditioner P DE can then be taken as follows:

(2.3) P DE = I 0 α 2 I α 1 B + B D A + B C ( α 1 1 ) B I + D C I

for the system (2.2). The difference between H and P DE is clearly

(2.4) Δ H = H P DE = 0 0 ( 1 α 2 ) I 0 0 0 0 0 0 .

Furthermore, the following results apply to the distributions of the eigenvalues of the preconditioned matrix P DE 1 H .

Theorem 1

The preconditioned matrix P DE 1 H has an eigenvalue of 1 with a multiplicity of at least n + m , and all of the remaining eigenvalues λ ’s are eigenvalues of V 1 ( C A 1 B D ) , where V = ( 1 α 2 ) I α 2 D .

Proof

By using some simple computations, and noting that α 1 + α 2 α 1 α 2 2 = 0 , it is easy to obtain

P DE 1 = I α 2 V 1 C A 1 α 2 V 1 0 A 1 0 0 V 1 C A 1 V 1 I 0 0 ( 1 α 1 ) B I B ( I + D ) 0 I .

From the expression of V , we deduce that α 2 V 1 V 1 + α 2 V 1 D = I , and hence,

P DE 1 Δ H = I α 2 V 1 C A 1 α 2 V 1 0 A 1 0 0 V 1 C A 1 V 1 0 0 ( 1 α 2 ) I 0 0 B 0 0 ( α 2 1 ) ( I + D ) = 0 0 W 1 0 0 W 2 0 0 W 3 ,

where

W 1 = ( 1 α 2 ) I + α 2 ( 1 α 2 ) V 1 [ ( 1 α 1 ) C A 1 B + I + D ] , W 2 = A 1 B , W 3 = V 1 [ C A 1 B D ] I .

As a result,

(2.5) P DE 1 H = I 0 W 1 0 I W 2 0 0 V 1 [ C A 1 B D ]

holds, and we know that the remaining eigenvalues λ ’s are all the eigenvalues of V 1 ( C A 1 B D ) . This completes the proof of Theorem 1.□

Remark 1

System (1.1) becomes a generalized saddle problem when A and D are all SPD and B = C T . Let S P ( W ) denote the spectrum of a matrix W , and suppose S P ( D ) [ μ 1 , μ n ] , S P ( C A 1 B ) [ σ 1 , σ n ] , then, from Theorem 1, we can easily obtain that the remaining eigenvalues λ ’s of P DE 1 H will be located in σ 1 + μ 1 α 2 1 + α 2 μ n , σ n + μ n α 2 1 + α 2 μ 1 as α 2 > 1 . When D is an indefinite matrix, we can ensure the invertibility of V by using a positive and small enough α 2 (say, 0 < α 2 < 1 1 + ρ ( D ) ), where ρ ( D ) is the spectral radius of D . In this case, the remaining eigenvalues λ ’s of P DE 1 H will be found in λ min ( C A 1 B D ) 1 α 2 α 2 ρ ( D ) , λ max ( C A 1 B D ) 1 α 2 α 2 ρ ( D ) .

Figures 1, 2, 3 depict the eigenvalue distributions of P DE 1 H , where H are, respectively, taken from Examples 1–3 in the following section. From these figures, we can see relatively clustered distribution of the eigenvalues of the preconditioned matrix P DE 1 H , and this can be especially noticed in Figure 2.

Figure 1 
               The eigenvalue distributions of the un-preconditioned/preconditioned matrix 
                     
                        
                        
                           
                              
                                 P
                              
                              
                                 DE
                              
                              
                                 −
                                 1
                              
                           
                           H
                        
                        {P}_{{\rm{DE}}}^{-1}H
                     
                   in Example 1, 
                     
                        
                        
                           
                              
                                 α
                              
                              
                                 2
                              
                           
                           =
                           1.3
                           ,
                           h
                           =
                           
                              
                                 1
                              
                              
                                 16
                              
                           
                           ,
                           γ
                           =
                           0.01
                           ,
                           ν
                           =
                           1
                        
                        {\alpha }_{2}=1.3,h=\frac{1}{16},\gamma =0.01,\nu =1
                     
                  , left: no preconditioner; right: DE preconditioner.
Figure 1

The eigenvalue distributions of the un-preconditioned/preconditioned matrix P DE 1 H in Example 1, α 2 = 1.3 , h = 1 16 , γ = 0.01 , ν = 1 , left: no preconditioner; right: DE preconditioner.

Figure 2 
               The eigenvalue distributions of the un-preconditioned/preconditioned matrix 
                     
                        
                        
                           
                              
                                 P
                              
                              
                                 DE
                              
                              
                                 −
                                 1
                              
                           
                           H
                        
                        {P}_{{\rm{DE}}}^{-1}H
                     
                   in Example 2, 
                     
                        
                        
                           
                              
                                 α
                              
                              
                                 2
                              
                           
                           =
                           1.01
                           ,
                           h
                           =
                           
                              
                                 1
                              
                              
                                 16
                              
                           
                           ,
                           τ
                           =
                           10
                        
                        {\alpha }_{2}=1.01,h=\frac{1}{16},\tau =10
                     
                  , upper left: no preconditioner, 
                     
                        
                        
                           ω
                           =
                           5
                           π
                        
                        \omega =5\pi 
                     
                  ; upper right: DE preconditioner, 
                     
                        
                        
                           ω
                           =
                           5
                           π
                        
                        \omega =5\pi 
                     
                  ; lower left: no preconditioner, 
                     
                        
                        
                           ω
                           =
                           10
                           π
                        
                        \omega =10\pi 
                     
                  ; lower right: DE preconditioner, 
                     
                        
                        
                           ω
                           =
                           10
                           π
                        
                        \omega =10\pi 
                     
                  .
Figure 2

The eigenvalue distributions of the un-preconditioned/preconditioned matrix P DE 1 H in Example 2, α 2 = 1.01 , h = 1 16 , τ = 10 , upper left: no preconditioner, ω = 5 π ; upper right: DE preconditioner, ω = 5 π ; lower left: no preconditioner, ω = 10 π ; lower right: DE preconditioner, ω = 10 π .

Figure 3 
               The eigenvalue distributions of the un-preconditioned/preconditioned matrix 
                     
                        
                        
                           
                              
                                 P
                              
                              
                                 DE
                              
                              
                                 −
                                 1
                              
                           
                           H
                        
                        {P}_{{\rm{DE}}}^{-1}H
                     
                   in Example 3, 
                     
                        
                        
                           
                              
                                 α
                              
                              
                                 2
                              
                           
                           =
                           1.00001
                        
                        {\alpha }_{2}=1.00001
                     
                  , 
                     
                        
                        
                           H
                        
                        H
                     
                   corresponds to “ck656.” left: no preconditioner; right: DE preconditioner.
Figure 3

The eigenvalue distributions of the un-preconditioned/preconditioned matrix P DE 1 H in Example 3, α 2 = 1.00001 , H corresponds to “ck656.” left: no preconditioner; right: DE preconditioner.

When using exact arithmetic in P DE , the following theorem demonstrates that the iterative solution of linear system (2.2) preconditioned by P DE lies in the ( n + 1 ) -dimensional space K ( P DE 1 H , P DE 1 r ) , allowing for fast generalized minimal residual method (GMRES) convergence.

Theorem 2

The degree of the minimal polynomial of preconditioned matrix P DE 1 H is at most n + 1 , and thus, the dimension of the Krylov subspace K ( P DE 1 H , b ) is at most n + 1 for any given vector b .

Proof

Because we know from (2.5) that the characteristic polynomial f ( λ ) of P DE 1 H is

f ( λ ) = det ( λ I ( m + 2 n ) P DE 1 H ) = ( λ 1 ) m + n det [ λ I n V 1 ( C A 1 B D ) ] = ( λ 1 ) m + n ( λ λ 1 ) ( λ λ n )

with λ i , i = 1 , 2 , , n the eigenvalues of V 1 ( C A 1 B D ) , f ( λ ) = 0 has at most n + 1 distinct roots λ i = λ i , i = 1 , 2 , , n , λ n + 1 = 1 , and the degree of the corresponding minimal polynomial of the preconditioned matrix is at most n + 1 . We can deduce from [33] that the dimension of the Krylov subspace K ( P DE 1 H , b ) is therefore at most n + 1 . This completes the proof of Theorem 2.□

We provide Algorithm 1 for practically implementing P DE 1 , which is obtained by considering the following factorization:

(2.6) P DE 1 = P 4 P 3 P 2 P 1 = α 2 V 1 I α 2 V 1 0 C I 0 I 0 V α 2 2 C α 2 I α 2 I A 1 I I 0 0 ( α 1 2 ) B α 2 I B I α 2 0 I .

Algorithm 1. Preconditioning operation P DE u = v
Step 1. Compute an incomplete LU or a Cholesky factorization of reordered matrices A and V using techniques such as approximate minimum degree permutation (amd).
Step 2. Calculate [ u 1 ( 1 ) , u 2 ( 1 ) , u 3 ( 1 ) ] = P 1 [ v 1 , v 2 , v 3 ] .
Step 3. Solve A u 2 * = u 2 ( 1 ) for u 2 * using the factorization of A obtained in Step 1 as a preconditioner.
Step 4. Calculate [ u 1 ( 2 ) , u 2 ( 2 ) , u 3 ( 2 ) ] = P 3 [ u 1 ( 1 ) , u 2 * , u 3 ( 1 ) ] .
Step 5. Solve V u 1 * = u 1 ( 2 ) , V u 3 * = u 3 ( 2 ) for u 1 * , u 3 * using the factorization of V obtained in Step 1 as a preconditioner, and calculate [ u 1 , u 2 , u 3 ] = [ α 2 u 1 * , u 2 ( 2 ) , α 2 u 3 * ] .

Remark 2

From (2.6), we can understand the relationship between α 1 and α 2 in Eqs. (2.2) is crucial. Evidently, without the equality α 1 = α 2 2 α 2 1 , we would be unable to obtain the factorization of P DE and hence, P DE 1 in (2.6).

Remark 3

We can see from Algorithm 1 that implementing P DE can avoid solving linear subsystems like (1.4)–(1.5), which can significantly reduce the average cost of the entire iterative solution when using a Krylov iterative method.

3 Numerical results

In this section, we give three numerical examples to investigate the practical efficiency of the P DE method (denoted by “DE”) using Matlab R2016a on a PC equipped with an Intel(R)Core(TM)i5-8265U processor (CPU@1.60GHz). We compare our method to four existing techniques, denoted by the letters “SHSS” (taken from [11]), “BS” (taken from paper [5]), “PS” (taken from [27]), and “BPS” (taken from [31]).

3.1 Characteristics of the model problems

The matrices in Example 1 are obtained by discretizing the well-known Navier-Stokes equations employing the mixed finite element of the bilinear pressure Q 1 P 0 pair with local stabilization. All matrices are generated by the IFISS software package provided by Davis and Hu [8]. When generating the required matrices, we run the driver “navier-testproblem” and select the problem “Lid driven cavity.” The viscosity parameter is set to ν = 1 , 0.01 , 0.0001 , the mesh steps are set to h = 1 16 , 1 32 , 1 64 , 1 128 , and all other parameters are set automatically by selecting the “default” option. Because the obtained sub-matrix B is rank deficient, we replace B with B ( 1 : n , 1 : n ) = B ( 1 : n , 1 : n ) + 0.0001 I n × n to ensure that the resulting matrix A B C D is nonsingular. In this example, the sub-matrix A is SPD, the sub-matrix D is SPSD, and B = C T . To compensate for the influence of the small viscosity ν , we scale the sub-matrices A and D into γ A , D γ while maintaining equivalence between the scaled and original systems.

Example 2 is the complex symmetric linear system (from [5])

(3.1) [ ( K ( 3 3 ) ω 2 I ) + i ( K + ( 3 + 3 ) τ 2 I ) ] x = b ,

in which ω and τ are two positive parameters and K is the five-point centered difference matrix approximating the negative Laplacian operator with homogeneous Dirichlet boundary conditions, namely,

K = I p V p + V p I p , h = 1 p + 1 , V p = h 2 tridiag ( 1 , 2 , 1 ) R p × p .

If we denote W = K ( 3 3 ) ω 2 I and T = K + ( 3 + 3 ) τ 2 I , then (3.1) is easily transformed into (1.3).

The matrices in Example 3 are taken from the University of Florida Sparse Matrix Collection (URL: https://sparse.tamu.edu/, see [7,8]), and they all represent the case of B ± C T and A , D are all nonsymmetric. The details of these tested matrices are shown in Table 1.

3.2 Experimental design

In all of these examples, the exact solution x exa is x = ones ( n + m , 1 ) . All of the subsystems M u = v involved in our numerical experiments are inexactly solved by GMRES or PCG; concretely, we first use the Matlab code “symamd” to obtain an approximate minimum degree permutation for M . Then, if M is not SPD, we compute an incomplete LU factorization with “droptol=1e-5” for M . Alternatively, if M is SPD, we compute an incomplete Cholesky factorization with “droptol=1e-5.” Then, we solve M u = v using either the GMRES method preconditioned by the triangular factors L and U (when M is not SPD) or the PCG method preconditioned by the triangular factors L , L T (when M is SPD). The convergence tolerance to terminate the iterations is set equal to “tol=1e-5.” We use the flexible GMRES (FGMRES) for Example 1 and GMRES for Examples 2 and 3 as the outer iteration, with a convergence tolerance of 1 × 1 0 8 and a maximum number of iterations of 1,000. Both relative errors between the exact and numerical solutions of these two iterative methods are reported.

In the following tables, we denote by “iter” the number of iterations required by the FGMRES and GMRES methods, and by “time” the elapsed CPU time in seconds, which includes the time for computing the “ilu”/“ichol” factorization as well as the time for iteratively solving the global preconditioned linear system. The symbol “ ” indicates that the FGMRES or GMRES method fails to converge. Furthermore, we report on the average cost of the five methods, denoted by “aver” in the tables and calculated as “time/iter.”

3.3 Analyses of the numerical results

The results presented in Tables 2, 3, 4, 5, 6, 7, 8 show that the proposed method is feasible.

  • When the dimension of H is large enough, “DE” is expected to outperform the other four methods in terms of iterations. This is reflected in Example 1 (Tables 24) and Example 2 (Tables 57).

  • When looking at the increasing rate of iterations, “DE” is relatively stable when compared to “SHSS,” “BS,” “PS,” and “BPS.” This is demonstrated in Examples 1 (Tables 24), 2 (Tables 57), and 3 (Table 8).

  • From the perspective of relative errors, “DE” is relative stable and accurate, similar to “SHSS,” “BS,” and “PS.”

  • In the case of high dimensional H , “DE” requires less CPU time than “SHSS,” “BS,” “PS,” and “BPS.” This is particularly evident in Examples 1 (Tables 24) and 2 (Tables 57).

  • DE” is feasible and efficient for all B = ± C T (Example 1), B = C (Example 2), and B ± C T (Example 3) cases.

Table 2

Numerical results of Example 1 ( ν = 1 , γ = 0.001 )

DE ( α 2 = 1.3 ) SHSS BPS
h iter errors time (s) aver iter errors time (s) aver iter errors time (s) aver
1/16 60 2.2 × 1 0 7 0.12 0.00 15 3.5 × 1 0 6 0.02 0.00 39 3.0 × 1 0 1 1.61 0.04
1/32 50 1.7 × 1 0 6 0.19 0.00 26 2.2 × 1 0 6 0.12 0.00 54 3.0 × 1 0 1 4.44 0.08
1/64 33 6.3 × 1 0 7 0.38 0.01 41 5.9 × 1 0 6 0.95 0.02 69 3.2 × 1 0 1 28.59 0.41
1/128 30 4.9 × 1 0 7 1.19 0.04 66 3.4 × 1 0 6 8.63 0.13 143 5.1 × 1 0 2 148.54 1.03
Table 3

Numerical results of Example 1 ( ν = 0.01 , γ = 0.2 )

DE ( α 2 = 1.3 ) SHSS BPS
h iter errors time (s) aver iter errors time (s) aver iter errors time (s) aver
1/16 55 1.0 × 1 0 6 0.11 0.00 19 6.5 × 1 0 8 0.04 0.00 29 1.1 × 1 0 6 0.11 0.00
1/32 40 7.8 × 1 0 6 0.15 0.00 32 7.9 × 1 0 8 0.12 0.00 49 2.1 × 1 0 6 0.80 0.02
1/64 30 3.2 × 1 0 6 0.36 0.01 53 6.8 × 1 0 8 1.12 0.02 87 5.1 × 1 0 8 29.45 0.33
1/128 31 7.7 × 1 0 7 1.24 0.04 87 5.1 × 1 0 8 10.40 0.12 126 1.4 × 1 0 7 72.81 0.57
Table 4

Numerical results of Example 1 ( ν = 0.0001 , γ = 20 )

DE ( α 2 = 1.3 ) SHSS BPS
h iter errors time (s) aver iter errors time (s) aver iter errors time (s) aver
1/16 55 1.0 × 1 0 6 0.12 0.00 19 3.1 × 1 0 7 0.03 0.00 210 2.0 × 1 0 6 2.35 0.01
1/32 40 7.8 × 1 0 6 0.15 0.00 32 1.7 × 1 0 7 0.12 0.00 576 2.8 × 1 0 6 16.69 0.02
1/64 30 3.2 × 1 0 6 0.36 0.01 54 1.3 × 1 0 7 1.12 0.02 636 4.2 × 1 0 6 52.15 0.08
1/128 31 8.0 × 1 0 7 1.30 0.04 90 2.4 × 1 0 8 11.73 0.13
Table 5

Numerical results of Example 2 ( ω = 5 π , τ = 10 )

DE ( α 2 = 1.01 ) BS
h iter errors time (s) aver iter errors time (s) aver
1/32 10 2.5 × 1 0 9 0.04 0.00 22 1.5 × 1 0 8 0.06 0.00
1/64 11 1.7 × 1 0 9 0.12 0.01 43 8.4 × 1 0 8 0.51 0.01
1/128 11 3.4 × 1 0 9 0.42 0.03 87 5.6 × 1 0 7 3.35 0.03
1/256 11 4.2 × 1 0 9 1.64 0.14 189 3.3 × 1 0 6 34.74 0.18
Table 6

Numerical results of Example 2 ( ω = 10 π , τ = 10 )

DE ( α 2 = 1.01 ) BS
h iter errors time (s) aver iter errors time (s) aver
1/32 12 3.2 × 1 0 8 0.05 0.00 13 4.3 × 1 0 9 0.04 0.00
1/64 13 2.4 × 1 0 8 0.12 0.01 28 6.9 × 1 0 8 0.28 0.01
1/128 14 2.3 × 1 0 8 0.52 0.03 54 3.3 × 1 0 7 2.40 0.04
1/256 14 3.0 × 1 0 8 2.51 0.17 112 1.9 × 1 0 6 28.59 0.25
Table 7

Numerical results of Example 2 ( ω = 15 π , τ = 10 )

DE ( α 2 = 1.01 ) BS
h iter errors time (s) aver iter errors time (s) aver
1/32 26 1.0 × 1 0 7 0.09 0.00 10 4.2 × 1 0 9 0.03 0.00
1/64 26 1.2 × 1 0 7 0.20 0.01 18 6.7 × 1 0 8 0.21 0.01
1/128 29 1.2 × 1 0 7 1.03 0.03 37 3.5 × 1 0 7 1.40 0.03
1/256 29 1.5 × 1 0 7 4.43 0.15 74 2.4 × 1 0 6 15.01 0.20
Table 8

Numerical results of Example 3

DE ( α 2 = 1.00001 ) PS
Matrices iter errors time (s) aver iter errors time (s) aver
dw256A 11 6.8 × 1 0 8 0.03 0.00 9 1.4 × 1 0 6 0.03 0.00
ck656 7 2.6 × 1 0 6 0.03 0.00 10 5.2 × 1 0 5 0.05 0.00
poli 6 2.8 × 1 0 9 0.05 0.00 3 1.0 × 1 0 11 0.04 0.01
poli-large 6 4.9 × 1 0 6 0.55 0.09 9 6.1 × 1 0 6 0.68 0.07
venkat25 64 9.9 × 1 0 7 19.55 0.30 58 1.7 × 1 0 6 19.87 0.34
poisson3db 108 7.5 × 1 0 6 32.17 0.29

4 Conclusion

In this article, we constructed a preconditioner for a general block two-by-two linear system (1.1) by expanding the dimension of the coefficient matrix. Theoretical analyses show that the presented preconditioner can result in a relatively well clustered distribution of the eigenvalues of the preconditioned matrix. For the inner subproblems, a concrete implementation scheme and an inexact solver are provided. To investigate the efficiency of the proposed preconditioner, numerical examples are provided. Theoretical results and numerical examples demonstrate that the preconditioner presented here is applicable for both B = ± C T and B ± C T .

  1. Funding information: This research was supported by the Scientific Research Fund of Hunan Provincial Science and Technology Department (2022JJ30416) and the Scientific Research Funds of Hunan Provincial Education Department (20A345 and 22A0483). The second author is a member of Gruppo Nazionale per il Calcolo Scientifico (GNCS) of Istituto Nazionale di Alta Matematica (INdAM), and this work was partially supported by INdAM-GNCS under Progetti di Ricerca 2023. The work of Jun Guo was supported by the Sichuan National Applied Mathematics co-construction project (2022ZX004), CUIT (KYTD202243), and the Scientific Research Foundation (KYTZ202184).

  2. Conflict of interest: The authors declare no potential conflict of interest.

References

[1] V. Girault and P. A. Raviart, Finite Element Methods for Navier-Stokes Equations: Theory and Algorithms, Springer Science & Business Media, NewYork, 2012. Search in Google Scholar

[2] Z. Chen, Finite Element Methods and Their Applications, Springer, Berlin, 2005. Search in Google Scholar

[3] G. Bao and W. Sun, A fast algorithm for the electromagnetic scattering from a large cavity, SIAM J. Sci. Comput. 27 (2005), 553–574. 10.1137/S1064827503428539Search in Google Scholar

[4] W. Van Dijk and F. M. Toyama, Accurate numerical solutions of the time-dependent Schrödinger equation, Phys. Rev. E. 75 (2007), 036707, 1–10. 10.1103/PhysRevE.75.036707Search in Google Scholar PubMed

[5] J.-H. Zhang and H. Dai, A new block preconditioner for complex symmetric indefinite linear systems, Numer. Algorithms 74 (2017), 889–903. 10.1007/s11075-016-0175-ySearch in Google Scholar

[6] Y. Cao and Z.-R. Ren, Two variants of the PMHSS iteration method for a class of complex symmetric indefinite linear systems, Appl. Math. Comput. 264 (2015), 61–71. 10.1016/j.amc.2015.04.049Search in Google Scholar

[7] K. Chen, Matrix Preconditioning Techniques and Applications, Cambridge University Press, Cambridge, 2005. 10.1017/CBO9780511543258Search in Google Scholar

[8] T. A. Davis and Y. Hu, The University of Florida sparse matrix collection, ACM Trans. Math. Software 38 (2011), no. 1, 1–25. 10.1145/2049662.2049663Search in Google Scholar

[9] M. Benzi and G. H. Golub, A preconditioner for generalized saddle point problems, SIAM J. Matrix. Anal. Appl. 26 (2004), no. 1, 20–41. 10.1137/S0895479802417106Search in Google Scholar

[10] Z.-Z. Bai, G. H. Golub, and M. K. Ng, Hermitian and skew-Hermitian splitting methods for non-Hermitian positive definite linear systems, SIAM J. Matrix. Anal. Appl. 24 (2003), no. 3, 603–626. 10.1137/S0895479801395458Search in Google Scholar

[11] Y. Cao, Z.-R. Ren, and Q. Shi, A simplified HSS preconditioner for generalized saddle point problems, BIT Numer. Math. 56 (2016), 423–439. 10.1007/s10543-015-0588-3Search in Google Scholar

[12] Y. Cao, L.-Q. Yao, and M.-Q. Jiang, A modified dimensional split preconditioner for generalized saddle point problems, J. Comput. Appl. Math. 250 (2013), 70–82. 10.1016/j.cam.2013.02.017Search in Google Scholar

[13] Y. Cao, S.-X. Miao, and Y.-S. Cui, A relaxed splitting preconditioner for generalized saddle point problems, Comput. Appl. Math. 34 (2015), 865–879. 10.1007/s40314-014-0150-ySearch in Google Scholar

[14] M. Benzi and X.-P. Guo, A dimensional split preconditioner for Stokes and linearized Navier-Stokes equations, Appl. Numer. Math. 61 (2011), no. 1, 66–76. 10.1016/j.apnum.2010.08.005Search in Google Scholar

[15] M. Benzi, M. Ng, N. Qiang, and W. Zhen, A relaxed dimensional factorization preconditioner for the incompressible Navier-Stokes equations, J. Comput. Phys. 230 (2011), 6185–6202. 10.1016/j.jcp.2011.04.001Search in Google Scholar

[16] J.-L. Zhang, An efficient variant of HSS preconditioner for generalized saddle point problems, Numer. Linear Algebra Appl. 25 (2018), no. 4, 1–14. 10.1002/nla.2166Search in Google Scholar

[17] Z.-Z. Bai, M. K. Ng, and Z.-Q. Wang, Constraint preconditioners for symmetric indefinite matrices, SIAM J. Matrix. Anal. Appl. 31 (2009), no. 2, 410–433. 10.1137/080720243Search in Google Scholar

[18] G.-F. Zhang, Z.-R. Ren, and Y.-Y. Zhou, On HSS-based constraint preconditioners for generalized saddle point problems, Numer. Algorithms, 57 (2011), 273–287. 10.1007/s11075-010-9428-3Search in Google Scholar

[19] Y. Cao, M.-Q. Jiang, and Y.-L. Zheng, A splitting preconditioner for saddle point problems, Numer. Linear Algebra Appl. 18 (2011), no. 5, 875–895. 10.1002/nla.772Search in Google Scholar

[20] I. N. Konshin, M. A. Olshanskii, and Y. V. Vassilevski, ILU preconditioners for nonsymmetric saddle-point matrices with application to the incompressible Navier-Stokes equations, SIAM J. Sci. Comput. 37 (2015), no. 5, A2171–A2197. 10.1137/15M1012311Search in Google Scholar

[21] J.-H. Zhang and H. Dai, A new splitting preconditioner for the iterative solution of complex symmetric indefinite linear systems, Appl. Math. Lett. 49 (2015), 100–106. 10.1016/j.aml.2015.05.006Search in Google Scholar

[22] Q.-Q. Shen and Q. Shi, A variant of the HSS preconditioner for complex symmetric indefinite linear systems, Comput. Math. Appl. 75 (2018), no. 3, 850–863. 10.1016/j.camwa.2017.10.006Search in Google Scholar

[23] M. Frigo, N. Castelletto, and M. Ferronato, A relaxed physical factorization preconditioner for mixed finite element coupled poromechanics, SIAM J. Sci. Comput. 41 (2019), no. 4, B694–B720. 10.1137/18M120645XSearch in Google Scholar

[24] M. J. Gander, Q. Niu, and Y. Xu, Analysis of a new dimension-wise splitting iteration with selective relaxation for saddle point problems, BIT Numer. Math. 56 (2016), no. 2, 441–465. 10.1007/s10543-016-0606-0Search in Google Scholar

[25] Y. Cao, J.-L. Dong, and Y.-M. Wang, A relaxed deteriorated PSS preconditioner for nonsymmetric saddle point problems from the steady Navier-Stokes equation, J. Comput. Appl. Math. 273 (2015), 41–60. 10.1016/j.cam.2014.06.001Search in Google Scholar

[26] Z.-Z. Bai, Structured preconditioners for nonsingular matrices of block two-by-two structures, Math. Comput. 75 (2006), 791–815. 10.1090/S0025-5718-05-01801-6Search in Google Scholar

[27] W. Chao, T.-Z. Huang, and C. Wen, A new preconditioner for indefinite and asymmetric matrices, Appl. Math. Comput. 219 (2013), 11036–11043. 10.1016/j.amc.2013.03.016Search in Google Scholar

[28] H. Chen, X. Li, and Y. Wang, A splitting preconditioner for a block two-by-two linear system with applications to the bidomain equations, J. Comput. Appl. Math. 321 (2017), 487–498. 10.1016/j.cam.2017.03.017Search in Google Scholar

[29] Q. Zheng and L. Lu, A shift-splitting preconditioner for a class of block two-by-two linear systems, Appl. Math. Lett. 66 (2016), no. 3, 54–60. 10.1016/j.aml.2016.11.009Search in Google Scholar

[30] M. Masoudi and D. K. Salkuyeh, An extension of the positive-definite and skew-Hermitian splitting method for preconditioning of generalized saddle point problems, Comput. Math. Appl. 79 (2020), no. 8, 2304–2321. 10.1016/j.camwa.2019.10.030Search in Google Scholar

[31] Y. Cao, A block positive-semidefinite splitting preconditioner for generalized saddle point linear systems, J. Comput. Appl. Math. 374 (2020), 112787. 10.1016/j.cam.2020.112787Search in Google Scholar

[32] W.-H. Luo, X.-M. Gu, and B. Carpentieri, A dimension expanded preconditioning technique for saddle point problems, BIT Numer. Math. 62 (2022), no. 4, 1983–2004. 10.1007/s10543-022-00938-8Search in Google Scholar

[33] Y. Saad, Iterative Methods for Sparse Linear Systems, SIAM, Philadelphia, PA, 2003. 10.1137/1.9780898718003Search in Google Scholar

Received: 2022-12-01
Revised: 2023-05-20
Accepted: 2023-06-17
Published Online: 2023-10-31

© 2023 the author(s), published by De Gruyter

This work is licensed under the Creative Commons Attribution 4.0 International License.

Articles in the same Issue

  1. Regular Articles
  2. A novel class of bipolar soft separation axioms concerning crisp points
  3. Duality for convolution on subclasses of analytic functions and weighted integral operators
  4. Existence of a solution to an infinite system of weighted fractional integral equations of a function with respect to another function via a measure of noncompactness
  5. On the existence of nonnegative radial solutions for Dirichlet exterior problems on the Heisenberg group
  6. Hyers-Ulam stability of isometries on bounded domains-II
  7. Asymptotic study of Leray solution of 3D-Navier-Stokes equations with exponential damping
  8. Semi-Hyers-Ulam-Rassias stability for an integro-differential equation of order 𝓃
  9. Jordan triple (α,β)-higher ∗-derivations on semiprime rings
  10. The asymptotic behaviors of solutions for higher-order (m1, m2)-coupled Kirchhoff models with nonlinear strong damping
  11. Approximation of the image of the Lp ball under Hilbert-Schmidt integral operator
  12. Best proximity points in -metric spaces with applications
  13. Approximation spaces inspired by subset rough neighborhoods with applications
  14. A numerical Haar wavelet-finite difference hybrid method and its convergence for nonlinear hyperbolic partial differential equation
  15. A novel conservative numerical approximation scheme for the Rosenau-Kawahara equation
  16. Fekete-Szegö functional for a class of non-Bazilevic functions related to quasi-subordination
  17. On local fractional integral inequalities via generalized ( h ˜ 1 , h ˜ 2 ) -preinvexity involving local fractional integral operators with Mittag-Leffler kernel
  18. On some geometric results for generalized k-Bessel functions
  19. Convergence analysis of M-iteration for 𝒢-nonexpansive mappings with directed graphs applicable in image deblurring and signal recovering problems
  20. Some results of homogeneous expansions for a class of biholomorphic mappings defined on a Reinhardt domain in ℂn
  21. Graded weakly 1-absorbing primary ideals
  22. The existence and uniqueness of solutions to a functional equation arising in psychological learning theory
  23. Some aspects of the n-ary orthogonal and b(αn,βn)-best approximations of b(αn,βn)-hypermetric spaces over Banach algebras
  24. Numerical solution of a malignant invasion model using some finite difference methods
  25. Increasing property and logarithmic convexity of functions involving Dirichlet lambda function
  26. Feature fusion-based text information mining method for natural scenes
  27. Global optimum solutions for a system of (k, ψ)-Hilfer fractional differential equations: Best proximity point approach
  28. The study of solutions for several systems of PDDEs with two complex variables
  29. Regularity criteria via horizontal component of velocity for the Boussinesq equations in anisotropic Lorentz spaces
  30. Generalized Stević-Sharma operators from the minimal Möbius invariant space into Bloch-type spaces
  31. On initial value problem for elliptic equation on the plane under Caputo derivative
  32. A dimension expanded preconditioning technique for block two-by-two linear equations
  33. Asymptotic behavior of Fréchet functional equation and some characterizations of inner product spaces
  34. Small perturbations of critical nonlocal equations with variable exponents
  35. Dynamical property of hyperspace on uniform space
  36. Some notes on graded weakly 1-absorbing primary ideals
  37. On the problem of detecting source points acting on a fluid
  38. Integral transforms involving a generalized k-Bessel function
  39. Ruled real hypersurfaces in the complex hyperbolic quadric
  40. On the monotonic properties and oscillatory behavior of solutions of neutral differential equations
  41. Approximate multi-variable bi-Jensen-type mappings
  42. Mixed-type SP-iteration for asymptotically nonexpansive mappings in hyperbolic spaces
  43. On the equation fn + (f″)m ≡ 1
  44. Results on the modified degenerate Laplace-type integral associated with applications involving fractional kinetic equations
  45. Characterizations of entire solutions for the system of Fermat-type binomial and trinomial shift equations in ℂn#
  46. Commentary
  47. On I. Meghea and C. S. Stamin review article “Remarks on some variants of minimal point theorem and Ekeland variational principle with applications,” Demonstratio Mathematica 2022; 55: 354–379
  48. Special Issue on Fixed Point Theory and Applications to Various Differential/Integral Equations - Part II
  49. On Cauchy problem for pseudo-parabolic equation with Caputo-Fabrizio operator
  50. Fixed-point results for convex orbital operators
  51. Asymptotic stability of equilibria for difference equations via fixed points of enriched Prešić operators
  52. Asymptotic behavior of resolvents of equilibrium problems on complete geodesic spaces
  53. A system of additive functional equations in complex Banach algebras
  54. New inertial forward–backward algorithm for convex minimization with applications
  55. Uniqueness of solutions for a ψ-Hilfer fractional integral boundary value problem with the p-Laplacian operator
  56. Analysis of Cauchy problem with fractal-fractional differential operators
  57. Common best proximity points for a pair of mappings with certain dominating property
  58. Investigation of hybrid fractional q-integro-difference equations supplemented with nonlocal q-integral boundary conditions
  59. The structure of fuzzy fractals generated by an orbital fuzzy iterated function system
  60. On the structure of self-affine Jordan arcs in ℝ2
  61. Solvability for a system of Hadamard-type hybrid fractional differential inclusions
  62. Three solutions for discrete anisotropic Kirchhoff-type problems
  63. On split generalized equilibrium problem with multiple output sets and common fixed points problem
  64. Special Issue on Computational and Numerical Methods for Special Functions - Part II
  65. Sandwich-type results regarding Riemann-Liouville fractional integral of q-hypergeometric function
  66. Certain aspects of Nörlund -statistical convergence of sequences in neutrosophic normed spaces
  67. On completeness of weak eigenfunctions for multi-interval Sturm-Liouville equations with boundary-interface conditions
  68. Some identities on generalized harmonic numbers and generalized harmonic functions
  69. Study of degenerate derangement polynomials by λ-umbral calculus
  70. Normal ordering associated with λ-Stirling numbers in λ-shift algebra
  71. Analytical and numerical analysis of damped harmonic oscillator model with nonlocal operators
  72. Compositions of positive integers with 2s and 3s
  73. Kinematic-geometry of a line trajectory and the invariants of the axodes
  74. Hahn Laplace transform and its applications
  75. Discrete complementary exponential and sine integral functions
  76. Special Issue on Recent Methods in Approximation Theory - Part II
  77. On the order of approximation by modified summation-integral-type operators based on two parameters
  78. Bernstein-type operators on elliptic domain and their interpolation properties
  79. A class of strongly convergent subgradient extragradient methods for solving quasimonotone variational inequalities
  80. Special Issue on Recent Advances in Fractional Calculus and Nonlinear Fractional Evaluation Equations - Part II
  81. Application of fractional quantum calculus on coupled hybrid differential systems within the sequential Caputo fractional q-derivatives
  82. On some conformable boundary value problems in the setting of a new generalized conformable fractional derivative
  83. A certain class of fractional difference equations with damping: Oscillatory properties
  84. Weighted Hermite-Hadamard inequalities for r-times differentiable preinvex functions for k-fractional integrals
  85. Special Issue on Recent Advances for Computational and Mathematical Methods in Scientific Problems - Part II
  86. The behavior of hidden bifurcation in 2D scroll via saturated function series controlled by a coefficient harmonic linearization method
  87. Phase portraits of two classes of quadratic differential systems exhibiting as solutions two cubic algebraic curves
  88. Petri net analysis of a queueing inventory system with orbital search by the server
  89. Asymptotic stability of an epidemiological fractional reaction-diffusion model
  90. On the stability of a strongly stabilizing control for degenerate systems in Hilbert spaces
  91. Special Issue on Application of Fractional Calculus: Mathematical Modeling and Control - Part I
  92. New conticrete inequalities of the Hermite-Hadamard-Jensen-Mercer type in terms of generalized conformable fractional operators via majorization
  93. Pell-Lucas polynomials for numerical treatment of the nonlinear fractional-order Duffing equation
  94. Impacts of Brownian motion and fractional derivative on the solutions of the stochastic fractional Davey-Stewartson equations
  95. Some results on fractional Hahn difference boundary value problems
  96. Properties of a subclass of analytic functions defined by Riemann-Liouville fractional integral applied to convolution product of multiplier transformation and Ruscheweyh derivative
  97. Special Issue on Development of Fuzzy Sets and Their Extensions - Part I
  98. The cross-border e-commerce platform selection based on the probabilistic dual hesitant fuzzy generalized dice similarity measures
  99. Comparison of fuzzy and crisp decision matrices: An evaluation on PROBID and sPROBID multi-criteria decision-making methods
  100. Rejection and symmetric difference of bipolar picture fuzzy graph
Downloaded on 23.9.2025 from https://www.degruyterbrill.com/document/doi/10.1515/dema-2023-0260/html?lang=en
Scroll to top button