Public Member Functions | Private Member Functions | Private Attributes | List of all members
oomph::AugmentedProblemGMRES Class Reference

//////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////// More...

#include <iterative_linear_solver.h>

+ Inheritance diagram for oomph::AugmentedProblemGMRES:

Public Member Functions

 AugmentedProblemGMRES (DoubleVector *b_pt, DoubleVector *c_pt, double *x_pt, double *rhs_pt)
 Constructor. More...
 
virtual ~AugmentedProblemGMRES ()
 Destructor: Clean up storage. More...
 
 AugmentedProblemGMRES (const AugmentedProblemGMRES &)=delete
 Broken copy constructor. More...
 
void operator= (const AugmentedProblemGMRES &)=delete
 Broken assignment operator. More...
 
void disable_resolve ()
 Overload disable resolve so that it cleans up memory too. More...
 
void solve (Problem *const &problem_pt, DoubleVector &result)
 Solver: Takes pointer to problem and returns the results vector which contains the solution of the linear system defined by the problem's fully assembled Jacobian and residual vector. More...
 
void solve (DoubleMatrixBase *const &matrix_pt, const DoubleVector &rhs, DoubleVector &solution)
 Linear-algebra-type solver: Takes pointer to a matrix and rhs vector and returns the solution of the linear system. More...
 
void solve (DoubleMatrixBase *const &matrix_pt, const Vector< double > &rhs, Vector< double > &result)
 Linear-algebra-type solver: Takes pointer to a matrix and rhs vector and returns the solution of the linear system Call the broken base-class version. If you want this, please implement it. More...
 
void resolve (const DoubleVector &rhs, DoubleVector &result)
 Re-solve the system defined by the last assembled Jacobian and the rhs vector specified here. Solution is returned in the vector result. More...
 
unsigned iterations () const
 Number of iterations taken. More...
 
bool iteration_restart () const
 access function indicating whether restarted GMRES is used More...
 
void enable_iteration_restart (const unsigned &restart)
 switches on iteration restarting and takes as an argument the number of iterations after which the construction of the orthogonalisation basis vectors should be restarted More...
 
void disable_iteration_restart ()
 Switches off iteration restart. More...
 
void set_preconditioner_LHS ()
 Set left preconditioning (the default) More...
 
void set_preconditioner_RHS ()
 Enable right preconditioning. More...
 
- Public Member Functions inherited from oomph::IterativeLinearSolver
 IterativeLinearSolver ()
 Constructor: Set (default) trivial preconditioner and set defaults for tolerance and max. number of iterations. More...
 
 IterativeLinearSolver (const IterativeLinearSolver &)=delete
 Broken copy constructor. More...
 
void operator= (const IterativeLinearSolver &)=delete
 Broken assignment operator. More...
 
virtual ~IterativeLinearSolver ()
 Destructor (empty) More...
 
Preconditioner *& preconditioner_pt ()
 Access function to preconditioner. More...
 
Preconditioner *const & preconditioner_pt () const
 Access function to preconditioner (const version) More...
 
double & tolerance ()
 Access to convergence tolerance. More...
 
unsigned & max_iter ()
 Access to max. number of iterations. More...
 
void enable_doc_convergence_history ()
 Enable documentation of the convergence history. More...
 
void disable_doc_convergence_history ()
 Disable documentation of the convergence history. More...
 
void open_convergence_history_file_stream (const std::string &file_name, const std::string &zone_title="")
 Write convergence history into file with specified filename (automatically switches on doc). Optional second argument is a string that can be used (as a zone title) to identify what case we're running (e.g. what combination of linear solver and preconditioner or parameter values are used). More...
 
void close_convergence_history_file_stream ()
 Close convergence history output stream. More...
 
double jacobian_setup_time () const
 returns the time taken to assemble the jacobian matrix and residual vector More...
 
double linear_solver_solution_time () const
 return the time taken to solve the linear system More...
 
virtual double preconditioner_setup_time () const
 returns the the time taken to setup the preconditioner More...
 
void enable_setup_preconditioner_before_solve ()
 Setup the preconditioner before the solve. More...
 
void disable_setup_preconditioner_before_solve ()
 Don't set up the preconditioner before the solve. More...
 
void enable_error_after_max_iter ()
 Throw an error if we don't converge within max_iter. More...
 
void disable_error_after_max_iter ()
 Don't throw an error if we don't converge within max_iter (default). More...
 
void enable_iterative_solver_as_preconditioner ()
 Enables the iterative solver be used as preconditioner (when calling the solve method it bypass the setup solver method – currently only used by Trilinos solver —) More...
 
void disable_iterative_solver_as_preconditioner ()
 Disables the iterative solver be used as preconditioner (when calling the solve method it bypass the setup solver method – currently only used by Trilinos solver —) More...
 
- Public Member Functions inherited from oomph::LinearSolver
 LinearSolver ()
 Empty constructor, initialise the member data. More...
 
 LinearSolver (const LinearSolver &dummy)=delete
 Broken copy constructor. More...
 
void operator= (const LinearSolver &)=delete
 Broken assignment operator. More...
 
virtual ~LinearSolver ()
 Empty virtual destructor. More...
 
void enable_doc_time ()
 Enable documentation of solve times. More...
 
void disable_doc_time ()
 Disable documentation of solve times. More...
 
bool is_doc_time_enabled () const
 Is documentation of solve times enabled? More...
 
bool is_resolve_enabled () const
 Boolean flag indicating if resolves are enabled. More...
 
virtual void enable_resolve ()
 Enable resolve (i.e. store matrix and/or LU decomposition, say) Virtual so it can be overloaded to perform additional tasks. More...
 
virtual void solve_transpose (Problem *const &problem_pt, DoubleVector &result)
 Solver: Takes pointer to problem and returns the results vector which contains the solution of the linear system defined by the problem's fully assembled Jacobian and residual vector (broken virtual). More...
 
virtual void solve_transpose (DoubleMatrixBase *const &matrix_pt, const DoubleVector &rhs, DoubleVector &result)
 Linear-algebra-type solver: Takes pointer to a matrix and rhs vector and returns the solution of the linear system. More...
 
virtual void solve_transpose (DoubleMatrixBase *const &matrix_pt, const Vector< double > &rhs, Vector< double > &result)
 Linear-algebra-type solver: Takes pointer to a matrix and rhs vector and returns the solution of the linear system. More...
 
virtual void resolve_transpose (const DoubleVector &rhs, DoubleVector &result)
 Solver: Resolve the system defined by the last assembled jacobian and the rhs vector. Solution is returned in the vector result. (broken virtual) More...
 
virtual void enable_computation_of_gradient ()
 function to enable the computation of the gradient required for the globally convergent Newton method More...
 
void disable_computation_of_gradient ()
 function to disable the computation of the gradient required for the globally convergent Newton method More...
 
void reset_gradient ()
 function to reset the size of the gradient before each Newton solve More...
 
void get_gradient (DoubleVector &gradient)
 function to access the gradient, provided it has been computed More...
 
- Public Member Functions inherited from oomph::DistributableLinearAlgebraObject
 DistributableLinearAlgebraObject ()
 Default constructor - create a distribution. More...
 
 DistributableLinearAlgebraObject (const DistributableLinearAlgebraObject &matrix)=delete
 Broken copy constructor. More...
 
void operator= (const DistributableLinearAlgebraObject &)=delete
 Broken assignment operator. More...
 
virtual ~DistributableLinearAlgebraObject ()
 Destructor. More...
 
LinearAlgebraDistributiondistribution_pt () const
 access to the LinearAlgebraDistribution More...
 
unsigned nrow () const
 access function to the number of global rows. More...
 
unsigned nrow_local () const
 access function for the num of local rows on this processor. More...
 
unsigned nrow_local (const unsigned &p) const
 access function for the num of local rows on this processor. More...
 
unsigned first_row () const
 access function for the first row on this processor More...
 
unsigned first_row (const unsigned &p) const
 access function for the first row on this processor More...
 
bool distributed () const
 distribution is serial or distributed More...
 
bool distribution_built () const
 if the communicator_pt is null then the distribution is not setup then false is returned, otherwise return true More...
 
void build_distribution (const LinearAlgebraDistribution *const dist_pt)
 setup the distribution of this distributable linear algebra object More...
 
void build_distribution (const LinearAlgebraDistribution &dist)
 setup the distribution of this distributable linear algebra object More...
 

Private Member Functions

void clean_up_memory ()
 Cleanup data that's stored for resolve (if any has been stored) More...
 
void augmented_matrix_multiply (CRDoubleMatrix *matrix_pt, const DoubleVector &x, DoubleVector &soln)
 Multiply the vector x by the augmented system matrix. More...
 
void apply_schur_complement_preconditioner (const DoubleVector &rhs, DoubleVector &soln)
 Apply the block-diagonal Schur complement preconditioner to compute the LHS which has size N+1 (the augmented system size) More...
 
void solve_helper (DoubleMatrixBase *const &matrix_pt, const DoubleVector &rhs, DoubleVector &solution)
 General interface to solve function. More...
 
void update (const unsigned &k, const Vector< Vector< double >> &H, const Vector< double > &s, const Vector< DoubleVector > &v, DoubleVector &x)
 Helper function to update the result vector using the result, x=x_0+V_m*y. More...
 
void generate_plane_rotation (double &dx, double &dy, double &cs, double &sn)
 Helper function: Generate a plane rotation. This is done by finding the values of $ \cos(\theta) $ (i.e. cs) and \sin(\theta) (i.e. sn) such that: More...
 
void apply_plane_rotation (double &dx, double &dy, double &cs, double &sn)
 Helper function: Apply plane rotation. This is done using the update: More...
 

Private Attributes

unsigned Iterations
 Number of iterations taken. More...
 
unsigned Restart
 The number of iterations before the iteration proceedure is restarted if iteration restart is used. More...
 
bool Iteration_restart
 boolean indicating if iteration restarting is used More...
 
CRDoubleMatrixMatrix_pt
 Pointer to matrix. More...
 
DoubleVectorB_pt
 Pointer to the column vector in the bordered system. More...
 
DoubleVectorC_pt
 Pointer to the row vector in the bordered system. More...
 
double * X_pt
 Pointer to the last entry of the LHS vector in the bordered system. More...
 
double * Rhs_pt
 Pointer to the last entry of the RHS vector in the bordered system. More...
 
double Schur_complement_scalar
 The scalar component of the Schur complement preconditioner. More...
 
bool Resolving
 Boolean flag to indicate if the solve is done in re-solve mode, bypassing setup of matrix and preconditioner. More...
 
bool Matrix_can_be_deleted
 Boolean flag to indicate if the matrix pointed to be Matrix_pt can be deleted. More...
 
bool Preconditioner_LHS
 boolean indicating use of left hand preconditioning (if true) or right hand preconditioning (if false) More...
 

Additional Inherited Members

- Protected Member Functions inherited from oomph::DistributableLinearAlgebraObject
void clear_distribution ()
 clear the distribution of this distributable linear algebra object More...
 
- Protected Attributes inherited from oomph::IterativeLinearSolver
bool Doc_convergence_history
 Flag indicating if the convergence history is to be documented. More...
 
std::ofstream Output_file_stream
 Output file stream for convergence history. More...
 
double Tolerance
 Convergence tolerance. More...
 
unsigned Max_iter
 Maximum number of iterations. More...
 
PreconditionerPreconditioner_pt
 Pointer to the preconditioner. More...
 
double Jacobian_setup_time
 Jacobian setup time. More...
 
double Solution_time
 linear solver solution time More...
 
double Preconditioner_setup_time
 Preconditioner setup time. More...
 
bool Setup_preconditioner_before_solve
 indicates whether the preconditioner should be setup before solve. Default = true; More...
 
bool Throw_error_after_max_iter
 Should we throw an error instead of just returning when we hit the max iterations? More...
 
bool Use_iterative_solver_as_preconditioner
 Use the iterative solver as preconditioner. More...
 
bool First_time_solve_when_used_as_preconditioner
 When the iterative solver is used a preconditioner then we call the setup of solver method only once (the first time the solve method is called) More...
 
- Protected Attributes inherited from oomph::LinearSolver
bool Enable_resolve
 Boolean that indicates whether the matrix (or its factors, in the case of direct solver) should be stored so that the resolve function can be used. More...
 
bool Doc_time
 Boolean flag that indicates whether the time taken. More...
 
bool Compute_gradient
 flag that indicates whether the gradient required for the globally convergent Newton method should be computed or not More...
 
bool Gradient_has_been_computed
 flag that indicates whether the gradient was computed or not More...
 
DoubleVector Gradient_for_glob_conv_newton_solve
 DoubleVector storing the gradient for the globally convergent Newton method. More...
 
- Static Protected Attributes inherited from oomph::IterativeLinearSolver
static IdentityPreconditioner Default_preconditioner
 Default preconditioner: The base class for preconditioners is a fully functional (if trivial!) preconditioner. More...
 

Detailed Description

//////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////

The GMRES method.

Definition at line 1548 of file iterative_linear_solver.h.

Constructor & Destructor Documentation

◆ AugmentedProblemGMRES() [1/2]

oomph::AugmentedProblemGMRES::AugmentedProblemGMRES ( DoubleVector b_pt,
DoubleVector c_pt,
double *  x_pt,
double *  rhs_pt 
)
inline

Constructor.

Definition at line 1552 of file iterative_linear_solver.h.

References Iteration_restart, and Preconditioner_LHS.

◆ ~AugmentedProblemGMRES()

virtual oomph::AugmentedProblemGMRES::~AugmentedProblemGMRES ( )
inlinevirtual

Destructor: Clean up storage.

Definition at line 1571 of file iterative_linear_solver.h.

References clean_up_memory().

◆ AugmentedProblemGMRES() [2/2]

oomph::AugmentedProblemGMRES::AugmentedProblemGMRES ( const AugmentedProblemGMRES )
delete

Broken copy constructor.

Member Function Documentation

◆ apply_plane_rotation()

void oomph::AugmentedProblemGMRES::apply_plane_rotation ( double &  dx,
double &  dy,
double &  cs,
double &  sn 
)
inlineprivate

Helper function: Apply plane rotation. This is done using the update:

\[ \begin{bmatrix} dx \newline dy \end{bmatrix} \leftarrow \begin{bmatrix} \cos\theta & \sin\theta \newline -\sin\theta & \cos\theta \end{bmatrix} \begin{bmatrix} dx \newline dy \end{bmatrix}. \]

Definition at line 1913 of file iterative_linear_solver.h.

Referenced by solve_helper().

◆ apply_schur_complement_preconditioner()

void oomph::AugmentedProblemGMRES::apply_schur_complement_preconditioner ( const DoubleVector rhs,
DoubleVector soln 
)
inlineprivate

Apply the block-diagonal Schur complement preconditioner to compute the LHS which has size N+1 (the augmented system size)

Definition at line 1736 of file iterative_linear_solver.h.

References oomph::DistributableLinearAlgebraObject::distribution_pt(), i, oomph::LinearAlgebraDistribution::nrow(), oomph::IterativeLinearSolver::preconditioner_pt(), oomph::Preconditioner::preconditioner_solve(), and Schur_complement_scalar.

Referenced by solve_helper(), and update().

◆ augmented_matrix_multiply()

void oomph::AugmentedProblemGMRES::augmented_matrix_multiply ( CRDoubleMatrix matrix_pt,
const DoubleVector x,
DoubleVector soln 
)
inlineprivate

◆ clean_up_memory()

void oomph::AugmentedProblemGMRES::clean_up_memory ( )
inlineprivatevirtual

Cleanup data that's stored for resolve (if any has been stored)

Reimplemented from oomph::LinearSolver.

Definition at line 1687 of file iterative_linear_solver.h.

References Matrix_can_be_deleted, and Matrix_pt.

Referenced by disable_resolve(), solve(), and ~AugmentedProblemGMRES().

◆ disable_iteration_restart()

void oomph::AugmentedProblemGMRES::disable_iteration_restart ( )
inline

Switches off iteration restart.

Definition at line 1668 of file iterative_linear_solver.h.

References Iteration_restart.

◆ disable_resolve()

void oomph::AugmentedProblemGMRES::disable_resolve ( )
inlinevirtual

Overload disable resolve so that it cleans up memory too.

Reimplemented from oomph::LinearSolver.

Definition at line 1583 of file iterative_linear_solver.h.

References clean_up_memory(), and oomph::LinearSolver::disable_resolve().

◆ enable_iteration_restart()

void oomph::AugmentedProblemGMRES::enable_iteration_restart ( const unsigned &  restart)
inline

switches on iteration restarting and takes as an argument the number of iterations after which the construction of the orthogonalisation basis vectors should be restarted

Definition at line 1661 of file iterative_linear_solver.h.

References Iteration_restart, and Restart.

◆ generate_plane_rotation()

void oomph::AugmentedProblemGMRES::generate_plane_rotation ( double &  dx,
double &  dy,
double &  cs,
double &  sn 
)
inlineprivate

Helper function: Generate a plane rotation. This is done by finding the values of $ \cos(\theta) $ (i.e. cs) and \sin(\theta) (i.e. sn) such that:

\[ \begin{bmatrix} \cos\theta & \sin\theta \newline -\sin\theta & \cos\theta \end{bmatrix} \begin{bmatrix} dx \newline dy \end{bmatrix} = \begin{bmatrix} r \newline 0 \end{bmatrix}, \]

where $ r=\sqrt{pow(dx,2)+pow(dy,2)} $. The values of a and b are given by:

\[ \cos\theta=\dfrac{dx}{\sqrt{pow(dx,2)+pow(dy,2)}}, \]

and

\[ \sin\theta=\dfrac{dy}{\sqrt{pow(dx,2)+pow(dy,2)}}. \]

Taken from: Saad Y."Iterative methods for sparse linear systems", p.192

Definition at line 1868 of file iterative_linear_solver.h.

Referenced by solve_helper().

◆ iteration_restart()

bool oomph::AugmentedProblemGMRES::iteration_restart ( ) const
inline

access function indicating whether restarted GMRES is used

Definition at line 1653 of file iterative_linear_solver.h.

References Iteration_restart.

◆ iterations()

unsigned oomph::AugmentedProblemGMRES::iterations ( ) const
inlinevirtual

Number of iterations taken.

Implements oomph::IterativeLinearSolver.

Definition at line 1647 of file iterative_linear_solver.h.

References Iterations.

◆ operator=()

void oomph::AugmentedProblemGMRES::operator= ( const AugmentedProblemGMRES )
delete

Broken assignment operator.

◆ resolve()

void oomph::AugmentedProblemGMRES::resolve ( const DoubleVector rhs,
DoubleVector result 
)
virtual

Re-solve the system defined by the last assembled Jacobian and the rhs vector specified here. Solution is returned in the vector result.

\Short Re-solve the system defined by the last assembled Jacobian and the rhs vector specified here. Solution is returned in the vector result.

Reimplemented from oomph::LinearSolver.

Definition at line 2831 of file iterative_linear_solver.cc.

References Matrix_pt, Resolving, and solve().

◆ set_preconditioner_LHS()

void oomph::AugmentedProblemGMRES::set_preconditioner_LHS ( )
inline

Set left preconditioning (the default)

Definition at line 1674 of file iterative_linear_solver.h.

References Preconditioner_LHS.

◆ set_preconditioner_RHS()

void oomph::AugmentedProblemGMRES::set_preconditioner_RHS ( )
inline

Enable right preconditioning.

Definition at line 1680 of file iterative_linear_solver.h.

References Preconditioner_LHS.

◆ solve() [1/3]

void oomph::AugmentedProblemGMRES::solve ( DoubleMatrixBase *const &  matrix_pt,
const DoubleVector rhs,
DoubleVector solution 
)
inlinevirtual

Linear-algebra-type solver: Takes pointer to a matrix and rhs vector and returns the solution of the linear system.

Reimplemented from oomph::LinearSolver.

Definition at line 1596 of file iterative_linear_solver.h.

References oomph::DistributableLinearAlgebraObject::build_distribution(), oomph::DistributableLinearAlgebraObject::distribution_pt(), oomph::LinearSolver::Enable_resolve, Matrix_can_be_deleted, Matrix_pt, Resolving, and solve_helper().

◆ solve() [2/3]

void oomph::AugmentedProblemGMRES::solve ( DoubleMatrixBase *const &  matrix_pt,
const Vector< double > &  rhs,
Vector< double > &  result 
)
inlinevirtual

Linear-algebra-type solver: Takes pointer to a matrix and rhs vector and returns the solution of the linear system Call the broken base-class version. If you want this, please implement it.

Reimplemented from oomph::LinearSolver.

Definition at line 1634 of file iterative_linear_solver.h.

References oomph::LinearSolver::solve().

◆ solve() [3/3]

void oomph::AugmentedProblemGMRES::solve ( Problem *const &  problem_pt,
DoubleVector result 
)
virtual

Solver: Takes pointer to problem and returns the results vector which contains the solution of the linear system defined by the problem's fully assembled Jacobian and residual vector.

//////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////

Solver: Takes pointer to problem and returns the results vector which contains the solution of the linear system defined by the problem's fully assembled Jacobian and residual vector.

Implements oomph::LinearSolver.

Definition at line 2746 of file iterative_linear_solver.cc.

References oomph::DoubleVector::build(), oomph::DistributableLinearAlgebraObject::build_distribution(), oomph::DoubleVector::built(), clean_up_memory(), oomph::Problem::communicator_pt(), oomph::DistributableLinearAlgebraObject::distribution_pt(), oomph::LinearSolver::Doc_time, oomph::LinearSolver::Enable_resolve, oomph::Problem::get_jacobian(), oomph::IterativeLinearSolver::Jacobian_setup_time, Matrix_can_be_deleted, Matrix_pt, oomph::Problem::ndof(), oomph::oomph_info, oomph::DoubleVector::redistribute(), Resolving, Schur_complement_scalar, solve_helper(), and oomph::TimingHelpers::timer().

Referenced by resolve().

◆ solve_helper()

void oomph::AugmentedProblemGMRES::solve_helper ( DoubleMatrixBase *const &  matrix_pt,
const DoubleVector rhs,
DoubleVector solution 
)
private

General interface to solve function.

Linear-algebra-type solver: Takes pointer to a matrix and rhs vector and returns the solution of the linear system. based on the algorithm presented in Templates for the Solution of Linear Systems: Building Blocks for Iterative Methods, Barrett, Berry et al, SIAM, 2006 and the implementation in the IML++ library : http://math.nist.gov/iml++/.

Definition at line 2862 of file iterative_linear_solver.cc.

References apply_plane_rotation(), apply_schur_complement_preconditioner(), augmented_matrix_multiply(), B_pt, oomph::DoubleVector::build(), oomph::DoubleVector::built(), C_pt, oomph::LinearAlgebraDistribution::communicator_pt(), oomph::LinearAlgebraDistribution::distributed(), oomph::DistributableLinearAlgebraObject::distributed(), oomph::DistributableLinearAlgebraObject::distribution_pt(), oomph::IterativeLinearSolver::Doc_convergence_history, oomph::LinearSolver::Doc_time, oomph::DoubleVector::dot(), generate_plane_rotation(), i, oomph::DoubleVector::initialise(), Iteration_restart, Iterations, oomph::IterativeLinearSolver::Max_iter, oomph::DoubleVector::norm(), oomph::DistributableLinearAlgebraObject::nrow(), oomph::DoubleMatrixBase::nrow(), oomph::oomph_info, oomph::IterativeLinearSolver::Output_file_stream, Preconditioner_LHS, oomph::IterativeLinearSolver::preconditioner_pt(), oomph::IterativeLinearSolver::Preconditioner_setup_time, oomph::Preconditioner::preconditioner_solve(), Resolving, Restart, s, Schur_complement_scalar, oomph::Preconditioner::setup(), oomph::IterativeLinearSolver::Setup_preconditioner_before_solve, oomph::IterativeLinearSolver::Solution_time, oomph::Global_string_for_annotation::string(), oomph::IterativeLinearSolver::Throw_error_after_max_iter, oomph::TimingHelpers::timer(), oomph::IterativeLinearSolver::Tolerance, update(), and oomph::DoubleVector::values_pt().

Referenced by solve().

◆ update()

void oomph::AugmentedProblemGMRES::update ( const unsigned &  k,
const Vector< Vector< double >> &  H,
const Vector< double > &  s,
const Vector< DoubleVector > &  v,
DoubleVector x 
)
inlineprivate

Member Data Documentation

◆ B_pt

DoubleVector* oomph::AugmentedProblemGMRES::B_pt
private

Pointer to the column vector in the bordered system.

Definition at line 1939 of file iterative_linear_solver.h.

Referenced by solve_helper().

◆ C_pt

DoubleVector* oomph::AugmentedProblemGMRES::C_pt
private

Pointer to the row vector in the bordered system.

Definition at line 1942 of file iterative_linear_solver.h.

Referenced by augmented_matrix_multiply(), and solve_helper().

◆ Iteration_restart

bool oomph::AugmentedProblemGMRES::Iteration_restart
private

boolean indicating if iteration restarting is used

Definition at line 1933 of file iterative_linear_solver.h.

Referenced by AugmentedProblemGMRES(), disable_iteration_restart(), enable_iteration_restart(), iteration_restart(), and solve_helper().

◆ Iterations

unsigned oomph::AugmentedProblemGMRES::Iterations
private

Number of iterations taken.

Definition at line 1926 of file iterative_linear_solver.h.

Referenced by iterations(), and solve_helper().

◆ Matrix_can_be_deleted

bool oomph::AugmentedProblemGMRES::Matrix_can_be_deleted
private

Boolean flag to indicate if the matrix pointed to be Matrix_pt can be deleted.

Definition at line 1959 of file iterative_linear_solver.h.

Referenced by clean_up_memory(), and solve().

◆ Matrix_pt

CRDoubleMatrix* oomph::AugmentedProblemGMRES::Matrix_pt
private

Pointer to matrix.

Definition at line 1936 of file iterative_linear_solver.h.

Referenced by clean_up_memory(), resolve(), and solve().

◆ Preconditioner_LHS

bool oomph::AugmentedProblemGMRES::Preconditioner_LHS
private

boolean indicating use of left hand preconditioning (if true) or right hand preconditioning (if false)

Definition at line 1963 of file iterative_linear_solver.h.

Referenced by AugmentedProblemGMRES(), set_preconditioner_LHS(), set_preconditioner_RHS(), solve_helper(), and update().

◆ Resolving

bool oomph::AugmentedProblemGMRES::Resolving
private

Boolean flag to indicate if the solve is done in re-solve mode, bypassing setup of matrix and preconditioner.

Definition at line 1955 of file iterative_linear_solver.h.

Referenced by resolve(), solve(), and solve_helper().

◆ Restart

unsigned oomph::AugmentedProblemGMRES::Restart
private

The number of iterations before the iteration proceedure is restarted if iteration restart is used.

Definition at line 1930 of file iterative_linear_solver.h.

Referenced by enable_iteration_restart(), and solve_helper().

◆ Rhs_pt

double* oomph::AugmentedProblemGMRES::Rhs_pt
private

Pointer to the last entry of the RHS vector in the bordered system.

Definition at line 1948 of file iterative_linear_solver.h.

◆ Schur_complement_scalar

double oomph::AugmentedProblemGMRES::Schur_complement_scalar
private

The scalar component of the Schur complement preconditioner.

Definition at line 1951 of file iterative_linear_solver.h.

Referenced by apply_schur_complement_preconditioner(), solve(), and solve_helper().

◆ X_pt

double* oomph::AugmentedProblemGMRES::X_pt
private

Pointer to the last entry of the LHS vector in the bordered system.

Definition at line 1945 of file iterative_linear_solver.h.


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