|
IBAMR
IBAMR version 0.19.
|
Class BGaussSeidelPreconditioner is a block Gauss-Seidel preconditioner which implements the abstract LinearSolver interface. More...
#include <ibtk/BGaussSeidelPreconditioner.h>

Public Member Functions | |
| BGaussSeidelPreconditioner (std::string object_name, SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > input_db, const std::string &default_options_prefix) | |
| Constructor. More... | |
| ~BGaussSeidelPreconditioner () | |
| Destructor. More... | |
| void | setComponentPreconditioner (SAMRAI::tbox::Pointer< LinearSolver > preconditioner, unsigned int component) |
| Set the preconditioner to be employed on the specified vector component. More... | |
| void | setComponentOperators (const std::vector< SAMRAI::tbox::Pointer< LinearOperator > > &linear_ops, unsigned int component) |
| Set the linear operators to be employed on the specified vector component. More... | |
| void | setSymmetricPreconditioner (bool symmetric_preconditioner) |
| Indicate whether to apply the component preconditioners symmetrically. More... | |
| void | setReversedOrder (bool reverse_order) |
| Indicate whether to apply the component preconditioners in reversed order (i.e., starting with the last component and ending with the first component). More... | |
Linear solver functionality. | |
| bool | solveSystem (SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &x, SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &b) override |
| Solve the linear system of equations \(Ax=b\) for \(x\). More... | |
| void | initializeSolverState (const SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &x, const SAMRAI::solv::SAMRAIVectorReal< NDIM, double > &b) override |
| Compute hierarchy dependent data required for solving \(Ax=b\). More... | |
| void | deallocateSolverState () override |
| Remove all hierarchy dependent data allocated by initializeSolverState(). More... | |
Functions to access solver parameters. | |
| void | setInitialGuessNonzero (bool initial_guess_nonzero=true) override |
| Set whether the initial guess is non-zero. More... | |
| void | setMaxIterations (int max_iterations) override |
| Set the maximum number of iterations to use per solve. More... | |
Functions to access data on the most recent solve. | |
| std::map< unsigned int, SAMRAI::tbox::Pointer< LinearSolver > > | d_pc_map |
| std::map< unsigned int, std::vector< SAMRAI::tbox::Pointer< LinearOperator > > > | d_linear_ops_map |
| bool | d_symmetric_preconditioner = false |
| bool | d_reverse_order = false |
| int | getNumIterations () const override |
| Return the iteration count from the most recent linear solve. More... | |
| double | getResidualNorm () const override |
| Return the residual norm from the most recent iteration. More... | |
| BGaussSeidelPreconditioner ()=delete | |
| Default constructor. More... | |
| BGaussSeidelPreconditioner (const BGaussSeidelPreconditioner &from)=delete | |
| Copy constructor. More... | |
| BGaussSeidelPreconditioner & | operator= (const BGaussSeidelPreconditioner &that)=delete |
| Assignment operator. More... | |
| static std::vector< SAMRAI::tbox::Pointer< SAMRAI::solv::SAMRAIVectorReal< NDIM, double > > > | getComponentVectors (SAMRAI::tbox::ConstPointer< SAMRAI::solv::SAMRAIVectorReal< NDIM, double > > x) |
| Extract the individual components of a SAMRAI::solv::SAMRAIVectorReal object, and create individual SAMRAI::solv::SAMRAIVectorReal objects to correspond to each of the components. More... | |
Logging functions. | |
| virtual void | setLoggingEnabled (bool enable_logging=true) |
| Enable or disable logging. More... | |
| virtual bool | getLoggingEnabled () const |
| Determine whether logging is enabled or disabled. More... | |
| std::string | d_object_name = "unitialized" |
| bool | d_is_initialized = false |
| bool | d_homogeneous_bc = false |
| double | d_solution_time = std::numeric_limits<double>::quiet_NaN() |
| double | d_current_time = std::numeric_limits<double>::quiet_NaN() |
| double | d_new_time = std::numeric_limits<double>::quiet_NaN() |
| double | d_rel_residual_tol = 0.0 |
| double | d_abs_residual_tol = 0.0 |
| int | d_max_iterations = 100 |
| int | d_current_iterations = 0 |
| double | d_current_residual_norm = std::numeric_limits<double>::quiet_NaN() |
| SAMRAI::tbox::Pointer< HierarchyMathOps > | d_hier_math_ops |
| bool | d_hier_math_ops_external = false |
| bool | d_enable_logging = false |
| void | init (const std::string &object_name, bool homogeneous_bc) |
| virtual void | initSpecialized (const std::string &object_name, bool homogeneous_bc) |
Logging functions. | |
| virtual void | printClassData (std::ostream &stream) override |
| Print class data to stream. More... | |
| bool | d_initial_guess_nonzero = true |
| bool | d_nullspace_contains_constant_vec = false |
| std::vector< SAMRAI::tbox::Pointer< SAMRAI::solv::SAMRAIVectorReal< NDIM, double > > > | d_nullspace_basis_vecs |
This solver class performs a single block Gauss-Seidel sweep, applying specified component LinearSolver and LinearOperator objects to the components of a supplied SAMRAI::solv::SAMRAIVectorReal vector, and doing so in a multiplicative fashion. Note that the block Gauss-Seidel algorithm is not generally convergent, but can be used as a preconditioner for a KrylovLinearSolver.
Note that the default block Gauss-Seidel algorithm is not a symmetric linear operator, even if the individual component linear operators and solvers are symmetric. Instead, the algorithm applies the component preconditioners to the vector components starting with the first vector component and ending with the last vector component. The algorithm can be symmetrized via the setSymmetricPreconditioner() member function, and the order in which vector components are visited can be reversed via the setReversedOrder() member function.
Sample parameters for initialization from database (and their default values):
symmetric_preconditioner = FALSE // see setSymmetricPreconditioner() reverse_order = FALSE // see setReversedOrder() initial_guess_nonzero = FALSE // see setInitialGuessNonzero() rel_residual_tol = 1.0e-6 // see setRelativeTolerance() abs_residual_tol = 1.0e-30 // see setAbsoluteTolerance() max_iterations = 1 // see setMaxIterations()
| IBTK::BGaussSeidelPreconditioner::BGaussSeidelPreconditioner | ( | std::string | object_name, |
| SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > | input_db, | ||
| const std::string & | default_options_prefix | ||
| ) |
| IBTK::BGaussSeidelPreconditioner::~BGaussSeidelPreconditioner | ( | ) |
|
privatedelete |
|
privatedelete |
| from | The value to copy to this object. |
| void IBTK::BGaussSeidelPreconditioner::setComponentPreconditioner | ( | SAMRAI::tbox::Pointer< LinearSolver > | preconditioner, |
| unsigned int | component | ||
| ) |
| void IBTK::BGaussSeidelPreconditioner::setComponentOperators | ( | const std::vector< SAMRAI::tbox::Pointer< LinearOperator > > & | linear_ops, |
| unsigned int | component | ||
| ) |
| void IBTK::BGaussSeidelPreconditioner::setSymmetricPreconditioner | ( | bool | symmetric_preconditioner | ) |
| void IBTK::BGaussSeidelPreconditioner::setReversedOrder | ( | bool | reverse_order | ) |
|
overridevirtual |
Before calling solveSystem(), the form of the solution x and right-hand-side b vectors must be set properly by the user on all patch interiors on the specified range of levels in the patch hierarchy. The user is responsible for all data management for the quantities associated with the solution and right-hand-side vectors. In particular, patch data in these vectors must be allocated prior to calling this method.
| x | solution vector |
| b | right-hand-side vector |
Conditions on Parameters:
true if the solver converged to the specified tolerances, false otherwise Implements IBTK::GeneralSolver.
|
overridevirtual |
By default, the solveSystem() method computes some required hierarchy dependent data before solving and removes that data after the solve. For multiple solves that use the same hierarchy configuration, it is more efficient to:
Note that it is generally necessary to reinitialize the solver state when the hierarchy configuration changes.
| x | solution vector |
| b | right-hand-side vector |
Conditions on Parameters:
Reimplemented from IBTK::GeneralSolver.
|
overridevirtual |
Reimplemented from IBTK::GeneralSolver.
|
overridevirtual |
Reimplemented from IBTK::LinearSolver.
|
overridevirtual |
Reimplemented from IBTK::GeneralSolver.
|
overridevirtual |
Reimplemented from IBTK::GeneralSolver.
|
overridevirtual |
Reimplemented from IBTK::GeneralSolver.
|
privatedelete |
| that | The value to assign to this object. |
|
staticprivate |
|
virtualinherited |
Implementations can require the nullspace basis vectors to be orthogonal but should not assume the basis vectors to be orthonormal. If the basis vectors are not orthonormal, the solver may normalize them in place.
Reimplemented in IBTK::PETScKrylovLinearSolver, and IBTK::PETScLevelSolver.
|
virtualinherited |
|
virtualinherited |
|
virtualinherited |
Reimplemented in IBTK::PETScPCLSWrapper.
|
overridevirtualinherited |
Reimplemented from IBTK::GeneralSolver.
|
inherited |
|
virtualinherited |
|
virtualinherited |
Reimplemented in IBTK::FACPreconditioner, IBTK::NewtonKrylovSolver, and IBTK::KrylovLinearSolver.
|
virtualinherited |
|
virtualinherited |
Reimplemented in IBAMR::CIBStaggeredStokesSolver, IBTK::FACPreconditioner, IBTK::NewtonKrylovSolver, and IBTK::KrylovLinearSolver.
|
virtualinherited |
|
virtualinherited |
Reimplemented in IBAMR::CIBStaggeredStokesSolver, IBTK::FACPreconditioner, IBTK::NewtonKrylovSolver, and IBTK::KrylovLinearSolver.
|
virtualinherited |
|
virtualinherited |
Reimplemented in IBTK::NewtonKrylovSolver, and IBTK::KrylovLinearSolver.
|
virtualinherited |
|
virtualinherited |
Reimplemented in IBTK::PETScPCLSWrapper.
|
virtualinherited |
Reimplemented in IBTK::PETScPCLSWrapper.
|
virtualinherited |
Reimplemented in IBTK::PETScPCLSWrapper.
|
virtualinherited |
Reimplemented in IBTK::PETScPCLSWrapper.
|
virtualinherited |
Reimplemented in IBTK::PETScPCLSWrapper.
|
virtualinherited |
|
virtualinherited |
|
protectedinherited |
|
protectedvirtualinherited |
Reimplemented in IBTK::PoissonSolver.
|
private |
The component preconditioners.
|
private |
The component operators.
|
private |
Parameters to specify the ordering of the application of the component preconditioners.
|
private |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
|
protectedinherited |
1.8.17