Demo problem: A preconditioner for the solution of (pseudo-)solid mechanics problems with prescribed boundary motions

In this tutorial we re-visit the solution of solid mechanics problems in which the deformation of the domain boundary is prescribed and enforced by Lagrange multipliers. This functionality is required, e.g., when using (pseudo-)solid mechanics to update the shape of the fluid mesh in large-displacement fluid-structure interaction problems.

Here we focus on the efficient solution of the governing equations by GMRES, using the problem-specific block-preconditioner developed in

Muddle, R.L., Mihajlovic, M. & Heil, M. (2012) An efficient preconditioner for monolithically-coupled large-displacement fluid-structure interaction problems with pseudo-solid mesh updates. Journal of Computational Physics 231, 7315-7334. DOI: 10.1016/j.jcp.2012.07.001


Theory: Problem formulation, the resulting linear system and the preconditioner

We refer to another tutorial for a detailed description of the problem setup and its discretisation. Briefly, we consider the deformation of an elastic solid body whose shape is parametrised by Lagrangian coordinates $ \xi^i $. A part of the body's boundary, $ \partial D_{prescr}$, (which is parametrised by the boundary coordinate $ \zeta$) is displaced to a new position given by $ {\bf R}_{prescr}(\zeta) $ while the other boundaries are held in a fixed position (as in the sketch below) or are subject to traction boundary conditions.

Sketch of the typical problem.

We discretise the problem using SolidElements in the bulk of the domain and employ lower-dimensional FaceElements to impose the displacement constraint along $ \partial D_{prescr}$. The problem therefore contains the following types of discrete unknowns:

  • The nodal positions (which are stored as positional Data at each SolidNode).

  • The nodal values representing the components of the (vector-valued) Lagrange multipliers. These only exist for the nodes on $ \partial D_{prescr}$. (The nodes are re-sized to accommodate the additional unknowns when the FaceElements are attached to the bulk elements.)

The preconditioner requires a further sub-division of these degrees of freedom into the following categories:

  • the x-coordinates of the unconstrained nodes
  • the y-coordinates of the unconstrained nodes
  • [the z-coordinates of the unconstrained nodes (only in 3D)]
  • the x-coordinates of the constrained nodes
  • the y-coordinates of the constrained nodes
  • [the z-coordinates of the constrained nodes (only in 3D)]
  • the x-component of the Lagrange multiplier at the constrained nodes
  • the y-component of the Lagrange multiplier at the constrained nodes
  • [the z-component of the Lagrange multiplier at the constrained nodes (only in 3D)].

For a 2D problem, the linear system to be solved in the course of the Newton iteration can then be (formally) re-ordered into the following block structure:

\[ \left[ \begin{array}{cccc|cc} { E_{\rm xx}}&{ E_{\rm x\bar{\rm x}}}&{ E_{\rm xy}}&{ E_{\rm x\bar{\rm y}}}&&\\ { E_{\bar{\rm x}\rm x}}&{ E_{\bar{\rm x}\bar{\rm x}}}&{ E_{\bar{\rm x}\rm y}}&{ E_{\bar{\rm x}\bar{\rm y}}}&{ M_{\rm x}}&\\ { E_{\rm yx}}&{ E_{\rm y\bar{\rm x}}}&{ E_{\rm yy}}&{ E_{\rm y\bar{\rm y}}}&&\\ { E_{\bar{\rm y}\rm x}}&{ E_{\bar{\rm y}\bar{\rm x}}}&{ E_{\bar{\rm y}\rm y}}&{ E_{\bar{\rm y}\bar{\rm y}}}&&{ M_{\rm y}}\\ \hline &{ M_{\rm x}}&&&\\ &&&{ M_{\rm y}}&& \end{array} \right] \left[ \begin{array}{c} \Delta \mathbf{X}_{\rm x}\\ \Delta \mathbf{\overline{X}}_{\rm x}\\ \Delta \mathbf{X}_{\rm y}\\ \Delta \mathbf{\overline{X}}_{\rm y}\\ \Delta \mathbf{L}_{\rm x}\\ \Delta \mathbf{L}_{\rm y} \end{array} \right] = - \left[ \begin{array}{c} \mathbf{r}_{\rm x}\\ \mathbf{r}_{\bar{\rm x}}\\ \mathbf{r}_{\rm y}\\ \mathbf{r}_{\bar{\rm y}}\\ \mathbf{r}_{\rm l_x}\\ \mathbf{r}_{\rm l_y} \end{array} \right]. \ \ \ \ \ \ (1) \]

Here the vectors ${\bf X}_{\rm x}$, ${\bf X}_{\rm y}$, ${\bf L}_{\rm x}$ and ${\bf L}_{\rm y}$ contain the $x$ and $y$ components of the unknown nodal positions and Lagrange multipliers, respectively. The overbars identify the unknown nodal positions that are constrained by the Lagrange multiplier. The matrices $M_{\rm x}$ and $M_{\rm y}$ are mass matrices whose entries are formed from products of the basis functions, $[M_{{\rm x}}]_{ij}=[M_{{\rm y}}]_{ij} = \int_{\partial D_{\rm prescr}} {\psi_i} \ {\psi_j} \ dS $.

Muddle, Mihajlovic & Heil (2012) show that

\[ {\cal P}_{\rm PS}=\left[ \begin{array}{cccc|cc} E_{\rm xx}&E_{\rm x\bar{\rm x}}&E_{\rm xy}&E_{\rm x\bar{\rm y}}&&\\ E_{\bar{\rm x}\rm x}&E_{\bar{\rm x}\bar{\rm x}}+\sigma I&E_{\bar{\rm x}\rm y}&E_{\bar{\rm x}\bar{\rm y}}&&\\ E_{\rm yx}&E_{\rm y\bar{\rm x}}&E_{\rm yy}&E_{\rm y\bar{\rm y}}&&\\ E_{\bar{\rm y}\rm x}&E_{\bar{\rm y}\bar{\rm x}}&E_{\bar{\rm y}\rm y}&E_{\bar{\rm y}\bar{\rm y}}+\sigma I&&\\ \hline &&&&\frac{1}{\sigma}M_{\rm x}^2&\\ &&&&&\frac{1}{\sigma}M_{\rm y}^2\\ \end{array} \right] \ \ \ \ \ \ (2) \]

is an optimal preconditioner for the linear system (1) if we set $ \sigma=\|E\|_{\infty} $ where $ E $ is the compound 4x4 top-left block

\[ E = \left[ \begin{array}{cccc} E_{\rm xx}&E_{\rm x\bar{\rm x}}&E_{\rm xy}&E_{\rm x\bar{\rm y}}\\ E_{\bar{\rm x}\rm x}&E_{\bar{\rm x}\bar{\rm x}} &E_{\bar{\rm x}\rm y}&E_{\bar{\rm x}\bar{\rm y}} \\ E_{\rm yx}&E_{\rm y\bar{\rm x}}&E_{\rm yy}&E_{\rm y\bar{\rm y}}\\ E_{\bar{\rm y}\rm x}&E_{\bar{\rm y}\bar{\rm x}}& E_{\bar{\rm y}\rm y}&E_{\bar{\rm y}\bar{\rm y}} \end{array} \right] \]

in the Jacobian matrix.

The application of the preconditioner (i.e. the solution of linear systems of the form $ {\cal P}_{\rm PS} \ {\bf x} = {\bf y} $ for $ {\bf x} $) requires three linear solves: One involving the compound 4x4 top-left block in $ {\cal P}_{\rm PS} $,

\[ E_{\rm PS}= \left[ \begin{array}{cccc} E_{\rm xx}&E_{\rm x\bar{\rm x}}&E_{\rm xy}&E_{\rm x\bar{\rm y}}\\ E_{\bar{\rm x}\rm x}&E_{\bar{\rm x}\bar{\rm x}}+\sigma I&E_{\bar{\rm x}\rm y}&E_{\bar{\rm x}\bar{\rm y}} \\ E_{\rm yx}&E_{\rm y\bar{\rm x}}&E_{\rm yy}&E_{\rm y\bar{\rm y}}\\ E_{\bar{\rm y}\rm x}&E_{\bar{\rm y}\bar{\rm x}}& E_{\bar{\rm y}\rm y}&E_{\bar{\rm y}\bar{\rm y}}+\sigma I \end{array} \right] \]

and two involving the two squared mass matrices, $ M_{\rm x}^2 $ and $ M_{\rm y}^2 $.

Numerical experiments in Muddle, Mihajlovic & Heil (2012) show that an efficient implementation of the preconditioner is obtained by replacing the $ E_{\rm PS} $ block in the preconditioner $ {\cal P}_{\rm PS} $ by its upper block-triangular approximation, corresponding to the preconditioner

\[ \widetilde{\cal P}_{\rm PS}=\left[ \begin{array}{cccc|cc} E_{xx}&E_{x\bar{x}}&E_{xy}&E_{x\bar{y}}&&\\ E_{\bar{x}x}&E_{\bar{x}\bar{x}}+\sigma I&E_{\bar{x}y}&E_{\bar{x}\bar{y}}&&\\ &&E_{yy}&E_{y\bar{y}}&&\\ &&E_{\bar{y}y}&E_{\bar{y}\bar{y}}+\sigma I&&\\ \hline &&&&\frac{1}{\sigma}M_x^2&\\ &&&&&\frac{1}{\sigma}M_y^2\\ \end{array} \right]. \ \ \ \ \ \ (3) \]

Furthermore, a fully optimal preconditioner (in which the solve times scale linearly with the number of unknowns) can be obtained by:

  • approximately solving the subsidiary linear systems involving the diagonal blocks

    \[ \left[ \begin{array}{cc} E_{xx}&E_{x\bar{x}}\\ E_{\bar{x}x}&E_{\bar{x}\bar{x}}+\sigma I\\ \end{array} \right] \mbox{\ \ \ \ and\ \ \ \ \ } \left[ \begin{array}{cc} E_{yy}&E_{y\bar{y}}\\ E_{\bar{y}y}&E_{\bar{y}\bar{y}}+\sigma I\\ \end{array} \right] \]

    in (3) by performing a fixed number of algebraic multigrid (AMG) cycles,

and by

  • approximately solving the subsidiary linear systems involving $ M_{\rm x}^2 $ and $ M_{\rm y}^2 $ by two consecutive linear solves involving the mass matrices themselves. Following Wathen [A. Wathen, "Realistic eigenvalue bounds for the Galerkin mass matrix", IMA Journal of Numerical Analysis 7 (1987) 449-457], Muddle, Mihajlovic & Heil (2012) suggest employing CG, preconditioned by diagonal scaling, as the solver for these systems. This solver converges so rapidly that a fixed number of four CG iterations suffices to compute the solution to sufficient accuracy so that $ \widetilde{\cal P}_{\rm PS} $ can be treated as a constant preconditioner.

With these approximations, the computational cost of one application of $ \widetilde{\cal P}_{\rm PS} $ is linear in the number of unknowns. The optimality of the preconditioner can therefore be assessed by demonstrating that the number of GMRES iterations remains constant under mesh refinement.



Implementation and use of the preconditioner

The preconditioner described above is implemented within oomph-lib's (parallel) block preconditioning framework which is described in another tutorial. For the purpose of the implementation, we decompose the preconditioning matrix into the 2x2 main blocks indicated by the vertical and horizontal lines in (2) and (3).

The application of the preconditioner requires the classification of the unknowns into the six (in 2D) different "dof types" discussed above. This is done on an element-by-element basis (since only the elements "know" what their nodal degrees of freedom correspond to) by implementing/overloading the functions

  • GeneralisedElement::ndof_types(...) which returns the number of dof types classified by that element.
  • GeneralisedElement::get_block_numbers_for_unknowns(...) which associates each degree of freedom (identified by its global equation number) with the dof type within its block.

For a 2D problem the enumeration of the dofs is chosen as follows. The SolidElements classify only the nodal positions and sub-divide them into those that are constrained and not constrained by the displacement boundary condition so that within that block

  • dof type 0 corresponds to the unconstrained x-nodal coordinates,
  • dof type 1 corresponds to the unconstrained y-nodal coordinates,
  • dof type 2 corresponds to the constrained x-nodal coordinates,
  • dof type 3 corresponds to the constrained y-nodal coordinates.

The FaceElements that apply the displacement constraint classify the Lagrange multipliers so that within that block

  • dof type 0 corresponds to the x-component of the Lagrange multiplier,
  • dof type 1 corresponds to the y-component of the Lagrange multiplier,

with the obvious generalisation to 3D.



Results

We examine the performance of the preconditioner in the test problem discussed in another tutorial: The upper surface of a unit square is subjected to a prescribed displacement that is imposed by Lagrange multipliers. The first of the two tables below shows the GMRES iteration counts (averaged over all linear solves performed in the course of all Newton iterations) as a function of the mesh refinement (represented by the total number of unknowns) for different implementations of the preconditioner.

  • "SuperLU" corresponds to the exact implementation of the preconditioner $ E_{\rm PS} $ in which the linear systems involving the matrix $ E_{\rm PS} $ and the two squared mass matrices, $ M_{\rm x}^2 $ and $ M_{\rm y}^2 $, are solved by SuperLU.
  • "Upper triangular E" corresponds to the case in which $ E_{\rm PS} $ is replaced by its upper block-triangular approximation (corresponding to $ \tilde{\cal P}_{\rm PS} $) but the four linear solves (two involving the diagonal blocks of $ E_{\rm PS} $; two involving the squared mass matrices, $ M_{\rm x}^2 $ and $ M_{\rm y}^2 $), are performed by SuperLU.
  • "Upper triangular E; Hypre/CG" are the results obtained when using the same block approximation of the preconditioner, but using two AMG cycles (performed with Hypre) for the approximate solution of the diagonal blocks of $ E_{\rm PS} $, and diagonally preconditioned CG as the approximate solver for the mass matrices.

n_dof 798 3198 12798 51198 204798
SuperLU 8.1 8.1 8.3 8.3 8.3
Upper triangular E 24.9 26.9 28.4 28.7 28.9
Upper triangular E; Hypre/CG 24.9 26.9 28.4 28.8 29.1
Table 1: Average GMRES iteration counts as a function of the mesh refinement (indicated by the number of unknowns, n_dof) for different implementations of the preconditioner.

As expected, the GMRES iteration counts are small and mesh independent for the exact implementation of the preconditioner. Replacing the (costly) exact solves by (faster) approximate solves leads to a modest increase in the (absolute) number of GMRES iterations, while retaining their virtual mesh independence under sufficiently strong mesh refinement.

The benefit of switching to the approximate solves becomes apparent in the next table which shows the average cpu times required for the solution of the linear systems by GMRES. For sufficiently fine discretisations the larger number of GMRES iterations for the inexact solves is more than compensated for by the much lower cost of the preconditioning operations. The final implementation yields cpu times that are proportional to the number of unknowns – the hallmark of an optimal solver.


n_dof 798 3198 12798 51198 204798
SuperLU 0.140409 0.720991 4.47518 35.1349 336.517
Upper triangular E 0.160478 0.737302 3.80428 22.6697 170.048
Upper triangular E; Hypre/CG 0.225759 0.895603 3.61778 15.8982 64.4825
Table 2: Average GMRES solve times [sec] as a function of the mesh refinement (indicated by the number of unknowns, n_dof) for different implementations of the preconditioner.



Modifications to the driver code

Most of the driver code is unchanged from the implementation discussed in the
original tutorial. We therefore only discuss the modifications required to employ preconditioned GMRES as the linear solver for the Newton method.


(Re-)classification of the dof types

As discussed above (and in the more detailed block-preconditioning tutorial, the classification of the degrees of freedom into different "dof types" has to be performed by the elements. Our implementation of the pseudo-elastic preconditioner treats the solver for the linear system involving $ E_{\rm PS} $ as a subsidiary preconditioner. oomph-lib's existing solid mechanics elements already provide dof classification for the nodal positions according to the coordinate directions (so for a 2D displacement-based solid element the call to ndof_types() will return 2 – the x and y nodal positions). If these elements are to be used with our preconditioner, this classification must be over-written to distinguish between constrained and unconstrained nodal positions. This is done most easily by providing a wrapper class (templated by the type of the underlying solid element) in the driver code to re-implement (overload) the relevant functions:

//=============start_wrapper==================================================
/// Pseudo-Elastic Solid element class to overload the block preconditioner
/// methods ndof_types() and get_dof_numbers_for_unknowns() to differentiate
/// between DOFs subject to Lagrange multiplier and those that are not.
//============================================================================
template <class ELEMENT>
class PseudoElasticBulkElement :
public virtual ELEMENT
{
public:
/// Constructor
PseudoElasticBulkElement() : ELEMENT() {}

The member function ndof_types() returns the number of dof types associated with (and classified by) this element: twice the number of spatial dimensions (for the constrained and unconstrained nodal positions).

/// Returns the number of DOF types associated with this element: Twice
/// the number of spatial dimensions (for the constrained and
/// unconstrained nodal positions).
unsigned ndof_types() const
{
return 2*ELEMENT::dim();
}

The member function get_dof_numbers_for_unknowns() returns a list of pairs, associating each (global) unknown (stored as the first entry in the pair) with the dof type within its block (stored as the second entry in the pair). We distinguish between constrained and unconstrained nodes by checking if the node has been resized to accommodate storage for the Lagrange multipliers. [Recall that FiniteElement::required_nvalue(j) returns the number of nodal values at local node j, required by the element itself (recall that for "pure" solid mechanics elements this number is zero because the nodal coordinates are stored as a separate Data item); Node::nvalue() returns the number of values actually stored at a Node – if this exceeds the value returned by FiniteElement::required_nvalue(j), node j must have been resized when the FaceElement applying the displacement constraint by Lagrange multipliers was attached.]

/// Create a list of pairs for all unknowns in this element,
/// so that the first entry in each pair contains the global equation
/// number of the unknown, while the second one contains the number
/// of the "DOF" that this unknown is associated with.
/// (Function can obviously only be called if the equation numbering
/// scheme has been set up.)\n
/// E.g. in a 3D problem there are 6 types of DOF:\n
/// 0 - x displacement (without lagr mult traction)\n
/// 1 - y displacement (without lagr mult traction)\n
/// 2 - z displacement (without lagr mult traction)\n
/// 4 - x displacement (with lagr mult traction)\n
/// 5 - y displacement (with lagr mult traction)\n
/// 6 - z displacement (with lagr mult traction)\n
void get_dof_numbers_for_unknowns(
std::list<std::pair<unsigned long,unsigned> >& dof_lookup_list) const
{
// temporary pair (used to store dof lookup prior to being added to list
std::pair<unsigned,unsigned> dof_lookup;
// number of nodes
const unsigned n_node = this->nnode();
//Get the number of position dofs and dimensions at the node
const unsigned n_position_type = ELEMENT::nnodal_position_type();
const unsigned nodal_dim = ELEMENT::nodal_dimension();
//Integer storage for local unknown
int local_unknown=0;
//Loop over the nodes
for(unsigned n=0;n<n_node;n++)
{
unsigned offset = 0;
if (this->node_pt(n)->nvalue() != this->required_nvalue(n))
{
offset = ELEMENT::dim();
}
//Loop over position dofs
for(unsigned k=0;k<n_position_type;k++)
{
//Loop over dimension
for(unsigned i=0;i<nodal_dim;i++)
{
//If the variable is unpinned
local_unknown = ELEMENT::position_local_eqn(n,k,i);
if (local_unknown >= 0)
{
// store dof lookup in temporary pair: First entry in pair
// is global equation number; second entry is dof type
dof_lookup.first = this->eqn_number(local_unknown);
dof_lookup.second = offset+i;
// add to list
dof_lookup_list.push_front(dof_lookup);
}
}
}
}
}
};

The ImposeDisplacementByLagrangeMultiplierElements which we use to impose the displacement constraint already label the x- and y- [and, in 3D, z-]component of the Lagrange multipliers as dof types 0, 1 [and 2], as required by our preconditioner. Therefore no modification is required.


Modifications to the main code

The main code only requires minor changes, all associated with the specification of different solver options. Since we provide the option to use Hypre and Trilinos solvers, we need to activate MPI if oomph-lib has been compiled with MPI support (even if the code is run in serial):

//=======start_of_main==================================================
/// Driver code
//======================================================================
int main(int argc, char* argv[])
{
#ifdef OOMPH_HAS_MPI
// Start up mpi if oomph-lib has been compiled with parallel support
// because parallel versions of trilinos and hypre which are then called
// by default) need it.
MPI_Helpers::init(argc,argv,false);
#endif
int main(int argc, char *argv[])
Driver code.

Next we define and process the possible command line flags which are used to select solver options and to specify the spatial resolution (in terms of of the number of elements in the x- and y-directions. The –no_adapt flag suppresses the spatial adaptivity to facilitate systematic mesh refinement studies.

// Store command line arguments
CommandLineArgs::setup(argc,argv);
// Define possible command line arguments and parse the ones that
// were actually specified
// Number of elements along axes
unsigned nel_1d=5;
CommandLineArgs::specify_command_line_flag("--nel_1d",&nel_1d);
// Suppress adaptation (for study of iteration count vs uniform mesh
// refinement, say)
CommandLineArgs::specify_command_line_flag("--no_adapt");
// Use block upper triangular preconditioner for elasticity block
CommandLineArgs::specify_command_line_flag("--block_upper_for_elastic_block");
// Use Hypre as subsidiary preconditioner (inexact solver) for
// linear (sub-)systems to be solved in the elastic block?
CommandLineArgs::specify_command_line_flag("--hypre_for_elastic_blocks");
// Use Trilinos CG as subsidiary preconditioner (inexact solver) for
// linear (sub-)systems to be solved in the Lagrange multiplier block?
CommandLineArgs::specify_command_line_flag
("--trilinos_cg_for_lagrange_multiplier_blocks");
// Use diagonal scaling as subsidiary preconditioner (inexact solver) for
// linear (sub-)systems to be solved in the elastic block?
// [only used for exercise]
CommandLineArgs::specify_command_line_flag
("--diagonal_scaling_for_elastic_blocks");

We then assign the command line flags that were specified and document the ones that were recognised before building the problem, specifying the "wrapped" version of the RefineableQPVDElement as the template parameter.

// Parse command line
CommandLineArgs::parse_and_assign();
// Doc what has actually been specified on the command line
CommandLineArgs::doc_specified_flags();
//Set up the problem with specified number of elements along axes.
PseudoElasticBulkElement<RefineableQPVDElement<2,3> > > problem(nel_1d);
Problem class for deformation of elastic block by prescribed boundary motion.

The rest of the main code is identical to the original version discussed in another tutorial and is therefore omitted here.


Modifications to the problem constructor

The majority of the problem constructor is unchanged from the original version of the code. Having created the bulk mesh (and stored a pointer to it in the private member Solid_mesh_pt) and the mesh of Lagrange multiplier elements (with a pointer stored in Lagrange_multiplier_mesh_pt), we specify a GMRES as the linear solver (using Trilinos' version of it, if available):

// Create the linear solver
IterativeLinearSolver* solver_pt=0;
// If we have trilinos, use it
#ifdef OOMPH_HAS_TRILINOS
// Create solver
solver_pt = new TrilinosAztecOOSolver;
// Use GMRES
dynamic_cast<TrilinosAztecOOSolver*>(solver_pt)->solver_type()
= TrilinosAztecOOSolver::GMRES;
#else
// Use oomph-lib's own GMRES
solver_pt = new GMRES<CRDoubleMatrix>;
#endif
// Set solver
linear_solver_pt() = solver_pt;

Next, we create an instance of our preconditioner, specify the meshes that contain the "bulk" solid and Lagrange multiplier elements, respectively, and pass the preconditioner to the iterative linear solver.

// Create the preconditioner
PseudoElasticPreconditioner * prec_pt = new PseudoElasticPreconditioner;
// Set solid and lagrange multiplier meshes
prec_pt->set_elastic_mesh(Solid_mesh_pt);
prec_pt->set_lagrange_multiplier_mesh(Lagrange_multiplier_mesh_pt);
// Set the preconditioner
solver_pt->preconditioner_pt() = prec_pt;

By default the preconditioner performs the preconditioning operations as described above, and performs the block solves in (2) exactly, using SuperLU.

The use of different blocked approximations to $ E_{\rm PS} $ is controlled via the elastic_preconditioner_type() function. It is possible to specify the block approximation in terms of the (self-explanatory) enumeration

  • PseudoElasticPreconditioner::Exact_block_preconditioner [the default]
  • PseudoElasticPreconditioner::Block_diagonal_preconditioner
  • PseudoElasticPreconditioner::Block_upper_triangular_preconditioner
  • PseudoElasticPreconditioner::Block_lower_triangular_preconditioner

So, to choose an upper block-triangular approximation for $ E_{\rm PS} $ we write

// Use upper block triangular preconditioner for elastic block?
if (CommandLineArgs::command_line_flag_has_been_set
("--block_upper_for_elastic_block"))
{
prec_pt->elastic_preconditioner_type()=
PseudoElasticPreconditioner::Block_upper_triangular_preconditioner;
}

By default the linear systems involving the diagonal blocks of $ E_{\rm PS} $ are performed by SuperLU. The function set_elastic_subsidiary_preconditioner(...) allows the specification of another (approximate) solver (or subsidiary preconditioner, in the terminology of oomph-lib's block preconditioning framework). The argument to this function is a pointer to a global function that returns an instance of the required solver. A function that creates an instantiation of Hypre's AMG solver (with suitable settings) is already implemented in the Pseudo_Elastic_Preconditioner_Subsidiary_Operator_Helper helper namespace and can be activated as follows:

#ifdef OOMPH_HAS_HYPRE
// Use Hypre as subsidiary preconditioner (inexact solver) for
// linear (sub-)systems to be solved in the elastic block?
if (CommandLineArgs::command_line_flag_has_been_set
("--hypre_for_elastic_blocks"))
{
prec_pt->set_elastic_subsidiary_preconditioner
(Pseudo_Elastic_Preconditioner_Subsidiary_Operator_Helper::
get_elastic_preconditioner_hypre);
}
#endif

(Recall that subsidiary preconditioners are deleted automatically by the master preconditioner when they are no longer required.)

A similar construction is used to specify alternative (approximate) solvers for the linear systems involving the mass matrices. To perform the solves with Trilinos' CG solver (and diagonal scaling) we state:

#ifdef OOMPH_HAS_TRILINOS
// Use Trilinos CG as subsidiary preconditioner (inexact solver) for
// linear (sub-)systems to be solved in the Lagrange multiplier block?
if (CommandLineArgs::command_line_flag_has_been_set
("--trilinos_cg_for_lagrange_multiplier_blocks"))
{
prec_pt->set_lagrange_multiplier_subsidiary_preconditioner
(Pseudo_Elastic_Preconditioner_Subsidiary_Operator_Helper::
get_lagrange_multiplier_preconditioner);
}
#endif

That's it!



Comments and Exercises

Comments

  • The machinery described here may seem rather heavy for a rather obscure problem. As mentioned at the beginning of this tutorial, the main purpose of this preconditioner is to act as a building block for our preconditioner for large-displacement FSI problems in which the ALE node update of the fluid mesh in response to the deformation of the fluid-loaded solid is handled by (pseudo-)elasticity. We refer to another tutorial for details.

  • Further details of the theory, such as the proof of the optimality of the preconditioner, can be found in
    Muddle, Mihajlovic & Heil (2012).

Exercises

  1. Experiment with alternative subsidiary preconditioners (inexact solvers) for the solution of the $ E_{\rm PS}$ block. For instance, set the argument to PseudoElasticPreconditioner::elastic_preconditioner_type() to PseudoElasticPreconditioner::Block_diagonal_preconditioner. With this setting, the solution of the linear systems involving $ E_{\rm PS}$ is performed using the block-diagonal approximation of $ E_{\rm PS}$. This saves one matrix-vector product with the off-diagonal blocks per iteration but
    significantly increases the GMRES iteration counts. [Don't take our word for it – try it!]

  2. Specify "your own" subsidiary preconditioner (inexact solver) by writing a global function (well, you should obviously hide it in a namespace – remember that global data and functions are evil!) that creates an instance of that preconditioner. Pass a function pointer to this function to PseudoElasticPreconditioner::set_elastic_subsidiary_preconditioner(). [Hint: The driver code already contains the relevant source lines (omitted in the code listings above) to illustrate how to solve the linear systems with a diagonal preconditioner. This leads to a fairly catastrophic deterioration of the GMRES iteration counts – the point of the exercise is to demonstrate how to implement such alternative (and hopefully better!) subsidiary preconditioners "from scratch".]

  3. Inspect (and experiment with) our settings for Hypre's AMG solver – defined in the Pseudo_Elastic_Preconditioner_Subsidiary_Operator_Helper namespace in

    src/multi_physics/pseudo_elastic_preconditioner.h


    and

    src/multi_physics/pseudo_elastic_preconditioner.cc


Source files for this tutorial



PDF file

A pdf version of this document is available.