Teko Version of the Day
Loading...
Searching...
No Matches
Public Member Functions | Protected Member Functions | List of all members
Teko::NS::ModALPreconditionerFactory Class Reference

Modified augmented Lagrangian-based preconditioner for incompressible Navier-Stokes equations. More...

#include <Teko_ModALPreconditionerFactory.hpp>

Inheritance diagram for Teko::NS::ModALPreconditionerFactory:
Inheritance graph
[legend]

Public Member Functions

void setPressureMassMatrix (const LinearOp &pressureMassMatrix)
 
void setGamma (double gamma)
 
virtual LinearOp buildPreconditionerOperator (BlockedLinearOp &alOp, BlockPreconditionerState &state) const
 
virtual Teuchos::RCP< PreconditionerStatebuildPreconditionerState () const
 
- Public Member Functions inherited from Teko::BlockPreconditionerFactory
virtual LinearOp buildPreconditionerOperator (BlockedLinearOp &blo, BlockPreconditionerState &state) const =0
 Function that is called to build the preconditioner for the linear operator that is passed in.
 
virtual RCP< PreconditionerStatebuildPreconditionerState () const
 Function that permits the construction of an arbitrary BlockPreconditionerState object.
 
RCP< BlockPreconditionerStatebuildBlockPreconditionerState () const
 Function that constructs a BlockPreconditionerState object.
 
virtual LinearOp buildPreconditionerOperator (LinearOp &blo, PreconditionerState &state) const
 Function that is called to build the preconditioner for the linear operator that is passed in.
 
bool isCompatible (const Thyra::LinearOpSourceBase< double > &fwdOpSrc) const
 is this operator compatiable with the preconditioner factory?
 
- Public Member Functions inherited from Teko::PreconditionerFactory
virtual LinearOp buildPreconditionerOperator (LinearOp &lo, PreconditionerState &state) const =0
 Function that is called to build the preconditioner for the linear operator that is passed in.
 
virtual Teuchos::RCP< PreconditionerStatebuildPreconditionerState () const
 Function that permits the construction of an arbitrary PreconditionerState object.
 
virtual void initializeFromParameterList (const Teuchos::ParameterList &)
 This function builds the internals of the preconditioner factory from a parameter list.
 
virtual Teuchos::RCP< Teuchos::ParameterList > getRequestedParameters () const
 Request the additional parameters this preconditioner factory needs.
 
virtual bool updateRequestedParameters (const Teuchos::ParameterList &)
 Update this object with the fields from a parameter list.
 
void setInverseLibrary (const Teuchos::RCP< const InverseLibrary > &il)
 Set the inverse library used by this preconditioner factory.
 
Teuchos::RCP< const InverseLibrary > getInverseLibrary () const
 Get the inverse library used by this preconditioner factory.
 
bool isCompatible (const Thyra::LinearOpSourceBase< double > &fwdOpSrc) const
 is this operator compatiable with the preconditioner factory?
 
Teuchos::RCP< Thyra::PreconditionerBase< double > > createPrec () const
 create an instance of the preconditioner
 
void initializePrec (const Teuchos::RCP< const Thyra::LinearOpSourceBase< double > > &fwdOpSrc, const Teuchos::RCP< const Thyra::MultiVectorBase< double > > &solnVec, Thyra::PreconditionerBase< double > *precOp, const Thyra::ESupportSolveUse supportSolveUse) const
 initialize a newly created preconditioner object
 
void initializePrec (const Teuchos::RCP< const Thyra::LinearOpSourceBase< double > > &fwdOpSrc, Thyra::PreconditionerBase< double > *precOp, const Thyra::ESupportSolveUse supportSolveUse) const
 initialize a newly created preconditioner object
 
void uninitializePrec (Thyra::PreconditionerBase< double > *prec, Teuchos::RCP< const Thyra::LinearOpSourceBase< double > > *fwdOpSrc, Thyra::ESupportSolveUse *supportSolveUse) const
 wipe clean a already initialized preconditioner object
 
void setParameterList (const Teuchos::RCP< Teuchos::ParameterList > &paramList)
 Set parameters from a parameter list and return with default values.
 
Teuchos::RCP< Teuchos::ParameterList > getNonconstParameterList ()
 Get the parameter list that was set using setParameterList().
 
Teuchos::RCP< Teuchos::ParameterList > unsetParameterList ()
 Unset the parameter list that was set using setParameterList().
 
void setRequestHandler (const Teuchos::RCP< RequestHandler > &rh)
 Set the request handler with pointers to the appropriate callbacks.
 
Teuchos::RCP< RequestHandlergetRequestHandler () const
 Get the request handler with pointers to the appropriate callbacks.
 
virtual void setRequestHandler (const Teuchos::RCP< RequestHandler > &rh)=0
 Set the request handler with pointers to the appropriate callbacks.
 
virtual Teuchos::RCP< RequestHandlergetRequestHandler () const =0
 Get the request handler with pointers to the appropriate callbacks.
 

Protected Member Functions

virtual LinearOp buildPreconditionerOperator (BlockedLinearOp &blo, BlockPreconditionerState &state) const=0
 Function that is called to build the preconditioner for the linear operator that is passed in.
 
virtual LinearOp buildPreconditionerOperator (LinearOp &blo, PreconditionerState &state) const
 Function that is called to build the preconditioner for the linear operator that is passed in.
 

Additional Inherited Members

- Static Public Member Functions inherited from Teko::PreconditionerFactory
static Teuchos::RCP< PreconditionerFactorybuildPreconditionerFactory (const std::string &name, const Teuchos::ParameterList &settings, const Teuchos::RCP< const InverseLibrary > &invLib=Teuchos::null)
 Builder function for creating preconditioner factories (yes this is a factory factory).
 
static void addPreconditionerFactory (const std::string &name, const Teuchos::RCP< Cloneable > &clone)
 Add a preconditioner factory to the builder. This is done using the clone pattern.
 
static void getPreconditionerFactoryNames (std::vector< std::string > &names)
 Get the names of the block preconditioner factories.
 
- Protected Attributes inherited from Teko::PreconditionerFactory
Teuchos::RCP< Teuchos::ParameterList > paramList_
 for ParameterListAcceptor
 
Teuchos::RCP< RequestHandlercallbackHandler_
 For handling requests and send requests back to the user.
 

Detailed Description

Modified augmented Lagrangian-based preconditioner for incompressible Navier-Stokes equations.

This class implements sparse matrix vector multiplication for augmented Lagrangian-based preconditioners. Details can be found in the following papers:

[1] Benzi, M. A. Olshanskii and Z. Wang, Modified Augmented Lagrangian Preconditioners for the Incompressible Navier-Stokes Equations, International Journal for Numerical Methods in Fluids, 66 (2011), pp. 486-508.

[2] M. Benzi and Z. Wang, Analysis of Augmented Lagrangian-Based Preconditioners for the Steady Incompressible Navier-Stokes Equations, SIAM J. Scientific Computing, 33 (2011), pp. 2761-2784.

Suppose we are solving the following linear system:

$
\left[ \begin{array}{cc}
A & B^T \\
B & -C
\end{array} \right]
\left[ \begin{array}{c}
u \\
p
\end{array} \right]
=
\left[ \begin{array}{c}
f \\
g
\end{array} \right].
$

The equivalent augmented Lagrangian (AL) formulation is:

$
\left[ \begin{array}{cc}
A + \gamma B^T W^{-1} B & B^T - \gamma B^T W^{-1} C \\
B & -C
\end{array} \right]
\left[ \begin{array}{c}
u \\
 p
\end{array} \right]
=
\left[ \begin{array}{c}
f + \gamma B^T W^{-1} g \\
g
\end{array} \right].
$

Here $ W $ can be take as the diagonal of the pressure mass matrix and $ \gamma $ is a positive number.

If $ A = (A_{11}, A_{12}; A_{21}, A_{22})
\quad \mathrm{and} \quad
B = (B_1, B_2)
$,

then the modified AL preconditioner is defined as

$
\left[ \begin{array}{ccc}
A_{11} + \gamma B_1^T W^{-1} B_1^T & A_{12} + \gamma B_1^T W^{-1} B_2^T & B_1^T - \gamma B_1^T W^{-1} C \\
0 & A_{22} + \gamma B_2^T W^{-1} B_2^T & B_1^T - \gamma B_2^T W^{-1} C \\
0 & 0 & S
\end{array} \right].
$

More details (analysis, numerical results) can be found in [2].

Definition at line 112 of file Teko_ModALPreconditionerFactory.hpp.

Member Function Documentation

◆ setPressureMassMatrix()

void Teko::NS::ModALPreconditionerFactory::setPressureMassMatrix ( const LinearOp &  pressureMassMatrix)
inline

Set pressure mass matrix.

Parameters
[in]pressureMassMatrixPressure mass matrix.

Definition at line 138 of file Teko_ModALPreconditionerFactory.hpp.

◆ setGamma()

void Teko::NS::ModALPreconditionerFactory::setGamma ( double  gamma)
inline

Set the augmentation parameter gamma.

Parameters
[in]gammaAugmentation paramter.

Definition at line 149 of file Teko_ModALPreconditionerFactory.hpp.

◆ buildPreconditionerOperator() [1/3]

LinearOp Teko::NS::ModALPreconditionerFactory::buildPreconditionerOperator ( BlockedLinearOp &  alOp,
BlockPreconditionerState state 
) const
virtual

Build modified AL preconditioner.

Parameters
[in]alOpThe AL operator.
[in]stateState object for storying reusable information about the AL operator.

Implements Teko::BlockPreconditionerFactory.

Definition at line 68 of file Teko_ModALPreconditionerFactory.cpp.

◆ buildPreconditionerState()

virtual Teuchos::RCP< PreconditionerState > Teko::NS::ModALPreconditionerFactory::buildPreconditionerState ( ) const
inlinevirtual

Build the ModALPrecondState object.

Reimplemented from Teko::BlockPreconditionerFactory.

Definition at line 170 of file Teko_ModALPreconditionerFactory.hpp.

◆ buildPreconditionerOperator() [2/3]

virtual LinearOp Teko::BlockPreconditionerFactory::buildPreconditionerOperator ( BlockedLinearOp &  blo,
BlockPreconditionerState state 
) const
protectedvirtual

Function that is called to build the preconditioner for the linear operator that is passed in.

This function builds a preconditioner based on the passed in BlockedLinearOp.

Parameters
[in]bloSource linear operator that is to be preconditioned.
[in]stateAn object associated with this operator to store the preconditioner state.
Returns
The preconditioner as a linear operator (i.e. to perform a matrix-vector operation simply call "apply").

Implements Teko::BlockPreconditionerFactory.

◆ buildPreconditionerOperator() [3/3]

LinearOp Teko::BlockPreconditionerFactory::buildPreconditionerOperator ( LinearOp &  lo,
PreconditionerState state 
) const
protectedvirtual

Function that is called to build the preconditioner for the linear operator that is passed in.

This function builds a preconditioner based on the passed in LinearOp.

Parameters
[in]loSource linear operator that is to be preconditioned.
[in]stateAn object associated with this operator to store the preconditioner state.
Returns
The preconditioner as a linear operator (i.e. to perform a matrix-vector operation simply call "apply").

Reimplemented from Teko::BlockPreconditionerFactory.

Definition at line 141 of file Teko_BlockPreconditionerFactory.cpp.


The documentation for this class was generated from the following files: