Elsevier

Parallel Computing

Volume 49, November 2015, Pages 164-178
Parallel Computing

Numerical and computational aspects of some block-preconditioners for saddle point systems

https://doi.org/10.1016/j.parco.2015.06.003Get rights and content

Highlights

  • Element-wise approximation of the Schur complement (EWS) for saddle point matrices.

  • Spectral bounds are shown when the Schur complement is symmetric negative definite.

  • EWS leads to a numerically and computationally optimal iterative solver.

  • Numerical simulations on various computer architectures.

Abstract

Linear systems with two-by-two block matrices are usually preconditioned by block lower- or upper-triangular systems that require an approximation of the related Schur complement. In this work, in the finite element framework, we consider one special such approximation, namely, the element-wise Schur complement. It is sparse and its construction is perfectly parallelizable, making it an appropriate ingredient when building preconditioners for iterative solvers executed on both distributed and shared memory computer architectures. For saddle point matrices with symmetric positive (semi-)definite blocks we show that the Schur complement is spectrally equivalent to the so-constructed approximation and derive spectral equivalence bounds. We also illustrate the quality of the approximation for nonsymmetric problems, where we observe the same good numerical efficiency.

Furthermore, we demonstrate the computational and numerical performance of the corresponding preconditioned iterative solution method on a large scale model benchmark problem originating from the elastic glacial isostatic adjustment model discretized using the finite element method.

Introduction

Performing large scale computer simulations of realistic models is a complex task that consists of several tightly interrelated aspects. Provided that the mathematical model is given, we need to consider the following phases: (1) choose a proper discretization method that guarantees the desired accuracy of the solution, (2) choose numerical solution techniques that are robust and efficient with respect to all involved problem and discretization parameters, (3) choose software implementation that will perform in a fast and scalable manner on current computer architectures. This study addresses the above issues and the interplay between discretization, data structures, numerical solution methods, program implementation and the resulting overall computational efficiency of the simulation.

The problem at hand is the glacial isostatic adjustment (GIA), it is the response of the solid Earth to changes in thickness and extent of ice sheets and glaciers. The GIA process causes subsidence or upliftment of the Earth surface and is currently active both in areas which were previously covered by large ice sheets during the latest glacial period and in currently deglaciating regions of the world. Performing consistent, reliable and fast numerical GIA simulations is becoming an increasingly important facet in the study of how glaciated areas will respond to the present global warming trend.

The Finite element framework has been used for many years in the geophysics community to simulate the GIA process, often using the functionality of general purpose commercial software packages such as ABAQUS, e.g. [1], [2]. However, enhanced numerical GIA simulations are not straightforwardly performed with ABAQUS or other commercial packages since important terms in the continuous GIA model, such as prestress advection, cannot be added directly, leading to the necessity to modify the model in order to be able to use the package. An extensively used implementation was provided by [1], [3] but this was shown to not perform well in the case of material compressibility [4]. Further, in particular for small displacement elasticity formulation, ABAQUS does not handle purely incompressible materials but only nearly incompressible. Also, the currently observed performance of the solvers when utilizing multicore architectures is by far not satisfactory for the target problem, which we illustrate with numerical experiments. Last but not least, the software is available at high cost and usually for limited computer facilities. With the focus on overcoming these problems, the present study is part of an effort aimed at implementing the GIA model for finite elements in its original form, to be described below, and allow to use the full range of values of the involved problem parameters. In addition, we aim at achieving optimal numerical efficiency, expressed in robustness of the solution methods with respect to problem, discretization and method parameters, as well as optimal computational efficiency, expressed in overall work, (nearly) linearly proportional to the number of degrees of freedom. Finally, we aim at good overall scalability when utilizing the nowadays high performance computer platforms. To this end we employ the publicly available software package Deal.II [5] that is flexible enough to provide the desired discretization methods and access to the basic numerical solution methods, but also allows for including user-designed building blocks to be used for facilitating the solution process. As we emphasize large scale and computationally heavy numerical simulations, we consider iterative solution methods to be the viable alternative. The latter automatically entails the need to choose an efficient and robust preconditioning technique, in order to accelerate the convergence of the iterative process.

When discretized, the mathematical model gives rise to linear systems with indefinite matrices of saddle point form, which we solve using state-of-the-art block-structured preconditioners. To achieve the desired overall efficiency, taking into account that the blocks of the system matrix are very large themselves, we use inner iterative solvers. This leads to inner–outer type of solution procedures and raises the necessity to properly choose the inner stopping tolerances so that we balance between computational burden and accurate enough block solvers to ensure the fast convergence of the outer method. In general, such preconditioners require a high quality sparse approximation of a (most often dense) Schur complement matrix.

In this paper we choose one particular sparse approximation of the Schur complement, the so-called element-wise approximation, that is particularly attractive for parallel implementation by construction. We prove the high quality of the approximate Schur complement for the class of symmetric indefinite matrices with a positive semi-definite pivot block. The so-constructed approximation is then used as a part of a block precondioner, applied to the discrete elastic GIA model, for which we test both numerical efficiency (number of iterations) and computational efficiency (time) on multicore CPU systems using the OpenMP (shared memory paradigm) and also the MPI (distributed memory) programming model. We demonstrate that open access numerical linear algebra toolboxes not only enable us to model the target problem in its original formulation but also allow us to implement efficient numerical solution techniques and achieve computational efficiency that outperforms the highly optimized sparse direct solvers in ABAQUS even in serial, and even for two-dimensional problems.

The paper is organized as follows. Section 2 comprises the description of the underlying problem of interest, its discretization and algebraic form. In Section 3 we describe the construction of the approximate Schur complement and analyze its quality when applied to indefinite matrices of saddle point form. We present the experimental setting in Section 4 and the obtained numerical results in Section 5. Some conclusions and an outlook are given in Section 6.

Section snippets

The mathematical model

The mathematical description of GIA processes employs a generalized visco-elastic rheology that accounts for viscous flow as the main mechanism of stress relaxation. Models describing the response of the solid Earth to a surface load, are based on the concept of isostacy, where the weight of the load is compensated for by adjustment in, and buoyancy of, the viscous mantle. The applied problem in its full complexity is described in [6], showing that the part, tested in this study, appears as a

Briefly on preconditioners for two-by-two block matrices

The scientific literature on preconditioners for two-by-two block systems is vast and here we present only some details, relevant for the cases, considered in this paper. For more details we refer to [14], [15] and the references therein.

We consider a preconditioning strategy based on the structure of the matrix, for systems in a two-by-two block form, and the discretization which in this case is a standard conforming Finite Element method (FEM).

To set up the notations, we formulate a general

Implementation details and hardware resources

Next we describe the software used to implement the solution procedure for (4), preconditioned by (5). The basic software tool we use to implement the GIA model is Deal.II. We use the interfaces Deal.II provides to access some other packages, in this case Trilinos and AGMG, that offer state-of-the-art linear solvers and preconditioners. The choice of the additional packages and the experimental results reflect the available functionality and performance at current time. As already noted, since

Numerical experiments and performance analysis

In this section we illustrate the performance of the designed solver in OpenMP and MPI setting. We recall that we solve the system (4) using the preconditioner from (5), B=[A0BS], where S is the element-wise Schur complement approximation, constructed according to (10). We recall that the quality of B as a preconditioner to A is controlled by the quality of S as an approximation of the true Schur complement SA and how accurate we solve systems with A and S, which we control by inner solvers,

Conclusion

The contribution of this paper is two-fold. We consider the element-wise sparse approximation of the negative Schur complement matrix for indefinite problems and study its quality. For saddle point matrices with symmetric positive (semi-)definite blocks we show that the negative Schur complement is spectrally equivalent to the so-constructed approximation and derive spectral equivalence bounds. We also illustrate the quality of the approximation for nonsymmetric problems, where we observe the

Acknowledgments

We acknowledge the help by Yvan Notay who provided the block-version of his AGMG code, that is particularly suited for systems with vector unknowns, as in linear elasticity.

We thank the anonymous reviewers for their comments that contributed to improve the presentation and the structure of the paper.

Parts of the computations were performed on resources provided by SNIC through Uppsala Multidisciplinary Center for Advanced Computational Science (UPPMAX) under Projects p2009040 and p2011076.

References (48)

  • M. Neytcheva

    On element-by-element Schur complement approximations

    Linear Algebra Appl.

    (2011)
  • J. Kraus, Additive Schur Complement Approximation for Elliptic Problems with Oscillatory Coefficients, vol. 7116,...
  • P. Wu

    Viscoelastic versus viscous deformation and the advection of pre-stress

    Geophys. J. Int.

    (1992)
  • P. Schmidt et al.

    Effects of present-day deglaciation in Iceland on mantle melt production rates

    J. Geophys. Res.: Solid Earth

    (2013)
  • P. Wu

    Using commercial finite element packages for the study of Earth deformations, sea levels and the state of stress

    Geophys. J. Int.

    (2004)
  • E. Bängtsson et al.

    A comparison between two solution techniques to solve the equations of glacially induced deformation of an elastic Earth

    Int. J. Numer. Methods Eng.

    (2008)
  • W. Bangerth, G. Kanschat, R. Hartmann, Deal.II Differential Equations Analysis Library,...
  • A. Dorostkar et al.

    Parallel Performance Study of Block-Preconditioned Iterative Methods on Multicore Computer Systems

    Technical Report 2014-007

    (2014)
  • P. Wu

    Modelling postglacial sea levels with power-law rheology and a realistic ice model in the absence of ambient tectonic stress

    Geophys. J. Int.

    (1999)
  • D. Braess

    Finite Elements, Theory, Fast Solvers, and Applications in Elasticity Theory

    (2007)
  • E. Bängtsson et al.

    Numerical simulations of glacial rebound using preconditioned iterative solution methods

    Appl. Math.

    (2005)
  • Y. Saad

    A flexible inner-outer preconditioned GMRES algorithm

    SIAM J. Sci. Comput.

    (1993)
  • O. Axelsson

    Iterative Solution Methods

    (1996)
  • M. Neytcheva et al.

    Preconditioning of nonsymmetric saddle point systems as arising in modelling of viscoelastic problems

    Electron. Trans. Numer. Anal.

    (2008)
  • D. Bertaccini et al.

    Preconditioned HSS methods for the solution of non-Hermitian positive definite linear systems and applications to the discrete convection-diffusion equation

    Numer. Math.

    (2005)
  • O. Axelsson et al.

    Eigenvalue estimates for preconditioned saddle point matrices

    Numer. Linear Algebra Appl.

    (2006)
  • M. Fortin et al.

    Mixed and Hybrid Finite Element Methods

    (1991)
  • Y. Saad et al.

    Gmres: a generalized minimal residual algorithm for solving nonsymmetric linear systems

    SIAM J. Sci. Stat. Comput.

    (1986)
  • M.F. Murphy et al.

    A note on preconditioning for indefinite linear systems

    SIAM J. Sci. Comput.

    (2000)
  • O. Axelsson et al.

    Preconditioning of boundary value problems using elementwise Schur complements

    SIAM J. Matrix Anal. Appl.

    (2009)
  • J. Kraus

    Algebraic multilevel preconditioning of finite element matrices using local Schur complements

    Numer. Linear Algebra Appl.

    (2006)
  • J. Kraus

    Additive Schur complement approximation and application to multilevel preconditioning

    SIAM J. Sci. Comput.

    (2012)
  • P. Boyanova et al.

    Robust AMLI methods for parabolic Crouzeix–Raviart FEM systems

    J. Comput. Appl. Math.

    (2010)
  • M. Neytcheva et al.

    Element-by-element Schur complement approximations for general nonsymmetric matrices of two-by-two block form

  • Cited by (8)

    • Function-based block multigrid strategy for a two-dimensional linear elasticity-type problem

      2017, Computers and Mathematics with Applications
      Citation Excerpt :

      The AGMG software is implemented in Fortran 90 and we use it via the provided Matlab interface. We note, that in [16] it is shown that AGMG is faster than the AMG implementation from the Trilinos library [42] both in terms of iterations and execution time. Moreover, we only focus on the comparison of the GLT-MG with the AGMG because the other AMG methods, available in Matlab, perform worse than AGMG.

    View all citing articles on Scopus
    View full text