Preconditioned iterative method for nonsymmetric saddle point linear systems

https://doi.org/10.1016/j.camwa.2021.07.002Get rights and content

Abstract

In this paper, a new preconditioned iterative method is presented to solve a class of nonsymmetric nonsingular or singular saddle point problems. The implementation of the proposed preconditioned Krylov subspace method avoids solving inverse of Schur complement and only needs to solve one linear sub-system at each step, which implies that it may save considerable costs. Theoretical convergence analysis, including the bounds of eigenvalues and eigenvectors, the degree of the minimal polynomial of the preconditioned matrix, are discussed in details. Moreover, a novel algebraic estimation technique for finding a practical iteration parameter is presented, which is very effective and practical even for large scale problems. At last, some numerical examples are carried, showing that the theoretical results are valid and convincing.

Introduction

In this paper, we focus ourselves on the solution of the following saddle point linear equationsAx=(ABBT0)(up)=(fg)=b, where ARn×n is a positive real matrix, i.e., its symmetric part is positive definite, BRn×m is a rectangular matrix with nm, u,fRn and p,gRm. Frequently, B is full rank, which means A is nonsingular. Whereas B may be rank deficient, in this case the coefficient matrix A is a singular matrix. In recent years, linear system (1.1) has got great attention owing to its widely applications in science and engineering problems [1], [2], [3], [4], [5]. To be more specific, we consider the following incompressible Navier-Stokes equations{νΔu+uu+p=f,inΩ,u=0,inΩ,u=g,onΩ in an open bounded domain ΩR2 (or R3) with boundary ∂Ω, ν>0 is the viscosity parameter. Linearization of the Navier-Stokes system (1.2) by Picard fixed-point iteration methods will involve in solving a sequence of Oseen problems of the form{νΔu+wu+p=f,inΩ,u=0,inΩ,u=g,onΩ, where the divergence free field w is the velocity field obtained from the previous Picard iteration step. We use finite element methods to discretize the Oseen equations (1.3). In order to guarantee a unique solution, we let the finite element discretization satisfy the Ladyzhenskaya-Babuša-Brezzi (LBB) condition. If we use the Q2Q1 element or Q2P1 element [5], then we will obtain the following large sparse systems of the formA+x=(ABBT0)(up)=(fg)b+, where A is a convection-diffusion-type matrix, B and BT are the discrete divergence and gradient matrices. u and p represent discrete velocity and pressure, respectively, and f and g contain forcing and boundary terms. By rearranging (1.4), it is easy to get (1.1). As shown in [5], if a finite element does not satisfy the LBB condition, we need to apply stabilization techniques to obtain a stable discretization scheme, which results in solving a generalized saddle point linear system of the following formA+x=(ABBTC)(up)=(fg)b˜+. However, the solution of linear system (1.5) is not within our consideration. Thus, in our experiments we have limited ourselves to finite elements that satisfy the BB condition.

Efficient solution of system (1.1) necessitates rapidly convergent iterative methods. Krylov subspace methods with a good preconditioner are considered for such large linear systems since they are cheap to implement and are able to exploit the sparsity of the coefficient matrix. It is well known that spectral distribution of the preconditioned matrix with a clustering of most of the eigenvalues relates closely to favorable convergence rate of Krylov subspace iterative methods, and the application of the preconditioner within a Krylov subspace method involves repeated solution of the linear system with the preconditioner as the coefficient matrix. Therefore, good preconditioner should be easily to implement [4].

In recent years, many effective preconditioners for Krylov subspace methods have been proposed. For examples, block preconditioners [2], [6], [7], constrained block preconditioners [8], [9], HSS preconditioners and its variants [10], [11], [12], [13], [14], [15], [16], [17], [18], DS(dimensional split)-like preconditioners [19], [20], other splitting preconditioners [21], [22], [23], [24], [25], [26], [27], [28], [29], [30], [31] and so on. For a survey of preconditioners for the saddle point problems, see [4] and the references therein.

Because of the advantage of the relaxation technique used in matrix splitting preconditioners, many existing preconditioners have been improved [14], [32], [33], [34], [35], [36], [37]. In fact, the relaxation technique was originally studied in [32] for the dimensional split preconditioner. Then this idea was extended to the HSS preconditioner [34], [35], the DPSS preconditioner [14], [33] and so on. For example, by taking use of the relaxation technique, Cao et al. proposed a simplified HSS (SHSS) preconditioner and proved that the SHSS preconditioner PSHSS is a better approximation to the matrix A and is easier to implement than the HSS preconditioner PHSS [34].

In this paper, motivated by relaxation technique and the preconditioner introduced in [27], we propose a new preconditioner for solving nonsingular or singular nonsymmetric saddle point problems. Convergence and semi-convergence for the corresponding iteration method are studied. The implementation of the preconditioned method is given, which shows that the proposed preconditioned GMRES method may save considerable costs. The eigen-properties of the preconditioned matrix are discussed and the dimension of the Krylov subspace methods for the preconditioned iteration method is obtained. Furthermore, a novel algebraic estimation technique for finding a practical iteration parameter is presented. Numerical experiments from Navier-Stokes equation show that the choice strategy of the practical iteration parameter is feasible, leading to the preconditioner' performance achieving faster convergence in terms of CPU time and iteration steps and fairly insensitive to the iteration parameter.

The remainder of the paper is organized as follows. In Section 2, new preconditioner and its implementation are given. In Section 3, for nonsingular saddle point problems, the convergence properties of the corresponding iterative method are studied, spectral properties of the preconditioned matrix are also discussed. Besides, selection strategy for the iteration parameter is studied. In Section 4, the new preconditioner is extended to solve singular linear system (1.1), semi-convergence of the corresponding iteration method is discussed. Numerical results are given in Section 5 to show the effectiveness of the new preconditioner. Finally, in Section 6, we draw some conclusions to end the paper.

Throughout this paper, σ(),ρ(), null(⋅), rank(⋅) and index(⋅) denote spectral set, spectral radius, null space, rank and index of a matrix, respectively.

Section snippets

New preconditioner and its implementation

For the coefficient matrix A in (1.1), let A=H˜+S˜ withH˜=(AB00)andS˜=(00BT0). Similar to the ADI splitting technique, we split A into:A=(α1I+H˜)(α1IS˜)=(α2I+S˜)(α2IH˜), where I denotes the identity matrix, and α1 and α2 are two positive parameters. Based on this splitting, Peng et al. [27] presented the following alternating(ALT) iteration method:{(α1I+H˜)x(k+12)=(α1IS˜)x(k)+b,(α2I+S˜)x(k+1)=(α2IH˜)x(k+12)+b. The corresponding ALT preconditioner PALT(α1,α2) is:PALT(α1,α2)=1(α1+α2)(α1I+H˜

Spectral analysis of preconditioned matrix and choice strategy of optimal parameter

The MALT iteration method and preconditioner can be used to solve both nonsingular and singular saddle point problems. In this section, we first discuss the convergence of the iteration method and spectral properties of preconditioned matrix for nonsingular saddle point problems, and then we will study a choice strategy of optimal iteration parameter.

The MALT iteration for singular saddle point problems

In this section, we consider using the MALT method to solve singular saddle point problem (1.1), i.e., the matrix B in (1.1) is rank deficient.

It is obviously that PMALT(α) defined in (2.4) is nonsingular. So implementation of the MALT iteration method for singular saddle point problem (1.1) is the same as Algorithm 2.1. To analyze semi-convergence of the MALT iteration method, we first give the following Lemma.

Lemma 4.1

([41]) The iterative schemex(k+1)=x(k)PMALT(α)1(Ax(k)b), is semi-convergent, if

Numerical experiments

In this section, we use some examples to examine the effectiveness of the MALT preconditioner. All tests are run in MATLAB (version R2013a) in double precision and all experiments are performed on a personal computer with 3.2 GHz CPU (Intel(R) Core(TM)2 i5-3470), 8G memory and windows 10 operating system.

In our implementations, all initial guess are chosen to be zero vectors and the iteration is terminated once the current iterate x(k) satisfiesERR=||bAx(k)||2||b||2107 or the number of the

Concluding remarks

In this paper, for solving nonsingular and singular saddle point problems, we propose a new modified alternating (MALT) preconditioner. The convergence and semi-convergence of the MALT preconditioner are discussed and some theoretical analysis for the eigenvalues of the associated preconditioned matrix are given. Furthermore, the choice for optimal parameter and practical parameter are studied separately, which are available even for large scale problems. It is worth mentioning that the new

References (45)

  • Y. Cao et al.

    A class of generalized shift-splitting preconditioners for nonsymmetric saddle point problems

    Appl. Math. Lett.

    (2015)
  • M. Benzi et al.

    A relaxed dimensional factorization preconditioner for the incompressible Navier-Stokes equations

    J. Comput. Phys.

    (2011)
  • Y.-M. Huang

    A practical formula for computing optimal parameters in the HSS iteration methods

    J. Comput. Appl. Math.

    (2014)
  • Y. Cao

    A block positive-semidefinite splitting preconditioner for generalized saddle point linear systems

    J. Comput. Appl. Math.

    (2020)
  • Z.-Z. Liang et al.

    PU-STS method for non-Hermitian saddle-point problems

    Appl. Math. Lett.

    (2015)
  • A.-L. Yang et al.

    On semi-convergence of the Uzawa-HSS method for singular saddle-point problems

    Appl. Math. Comput.

    (2015)
  • Y. Saad

    Iterative Methods for Sparse Linear Systems

    (2003)
  • Z.-Z. Bai

    Structured preconditioners for nonsingular matrices of block two-by-two structures

    Math. Comput.

    (2006)
  • G.H. Golub et al.

    An iteration for indefinite systems and its application to the Navier-Stokes equations

    SIAM J. Sci. Comput.

    (1998)
  • M. Benzi et al.

    Numerical solution of saddle point problems

    Acta Numer.

    (2005)
  • H.C. Elman et al.

    Finite Elements and Fast Iterative Solvers: With Applications in Incompressible Fluid Dynamics

    (2014)
  • Z.-Z. Bai et al.

    Block triangular and skew-Hermitian splitting methods for positive-definite linear systems

    SIAM J. Sci. Comput.

    (2005)
  • Cited by (2)

    This work was supported by the National Natural Science Foundation of China (No. 11901278, 11771193, 11961048) and NSF of Jiangxi Province (No. 20201BAB211002).

    View full text