//////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////// More...
#include <iterative_linear_solver.h>
Public Member Functions | |
GS () | |
Constructor. More... | |
virtual | ~GS () |
Destructor (cleanup storage) More... | |
GS (const GS &)=delete | |
Broken copy constructor. More... | |
void | operator= (const GS &)=delete |
Broken assignment operator. More... | |
void | smoother_solve (const DoubleVector &rhs, DoubleVector &result) |
The smoother_solve function performs fixed number of iterations on the system A*result=rhs. The number of (smoothing) iterations is the same as the max. number of iterations in the underlying IterativeLinearSolver class. More... | |
void | disable_resolve () |
Overload disable resolve so that it cleans up memory too. More... | |
void | smoother_setup (DoubleMatrixBase *matrix_pt) |
Set up the smoother for the matrix specified by the pointer. More... | |
void | setup_helper (DoubleMatrixBase *matrix_pt) |
Generic setup function to sort out everything that needs to be set up with regards to the input matrix. 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... | |
double | preconditioner_setup_time () const |
Returns the time taken to set up the preconditioner. More... | |
unsigned | iterations () const |
Number of iterations taken. More... | |
Public Member Functions inherited from oomph::Smoother | |
Smoother () | |
Empty constructor. More... | |
virtual | ~Smoother () |
Virtual empty destructor. More... | |
template<typename MATRIX > | |
void | check_validity_of_solve_helper_inputs (MATRIX *const &matrix_pt, const DoubleVector &rhs, DoubleVector &solution, const double &n_dof) |
Self-test to check that all the dimensions of the inputs to solve helper are consistent and everything that needs to be built, is. 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... | |
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... | |
LinearAlgebraDistribution * | distribution_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 | solve_helper (DoubleMatrixBase *const &matrix_pt, const DoubleVector &rhs, DoubleVector &solution) |
General interface to solve function. More... | |
void | clean_up_memory () |
Clean up data that's stored for resolve (if any has been stored) More... | |
Private Attributes | |
CRDoubleMatrix * | Matrix_pt |
System matrix pointer in the format specified by the template argument. More... | |
unsigned | Iterations |
Number of iterations taken. 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... | |
Vector< int > | Index_of_diagonal_entries |
Vector whose i'th entry contains the index of the last entry below or on the diagonal of the i'th row of the matrix. 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::Smoother | |
bool | Use_as_smoother |
When a derived class object is being used as a smoother in the MG solver (or elsewhere) the residual norm does not need to be calculated because we're simply performing a fixed number of (smoothing) iterations. This boolean is used as a flag to indicate that the IterativeLinearSolver (which this class is by inheritance) is supposed to act in this way. 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... | |
Preconditioner * | Preconditioner_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... | |
//////////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////////
Explicit template specialisation of the Gauss Seidel method for compressed row format matrices
Definition at line 784 of file iterative_linear_solver.h.
|
inline |
Constructor.
Definition at line 788 of file iterative_linear_solver.h.
|
inlinevirtual |
Destructor (cleanup storage)
Definition at line 797 of file iterative_linear_solver.h.
References oomph::GS< MATRIX >::clean_up_memory().
|
delete |
Broken copy constructor.
|
inlineprivatevirtual |
Clean up data that's stored for resolve (if any has been stored)
Reimplemented from oomph::LinearSolver.
Definition at line 958 of file iterative_linear_solver.h.
References oomph::GS< MATRIX >::Matrix_can_be_deleted, and oomph::GS< MATRIX >::Matrix_pt.
|
inlinevirtual |
Overload disable resolve so that it cleans up memory too.
Reimplemented from oomph::LinearSolver.
Definition at line 822 of file iterative_linear_solver.h.
References oomph::GS< MATRIX >::clean_up_memory(), and oomph::LinearSolver::disable_resolve().
|
inlinevirtual |
Number of iterations taken.
Implements oomph::IterativeLinearSolver.
Definition at line 945 of file iterative_linear_solver.h.
References oomph::GS< MATRIX >::Iterations.
|
delete |
Broken assignment operator.
|
inlinevirtual |
Returns the time taken to set up the preconditioner.
Reimplemented from oomph::IterativeLinearSolver.
Definition at line 929 of file iterative_linear_solver.h.
References oomph::Global_string_for_annotation::string().
|
inlinevirtual |
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 906 of file iterative_linear_solver.h.
References oomph::GS< MATRIX >::Matrix_pt, oomph::GS< MATRIX >::Resolving, and oomph::GS< MATRIX >::solve().
void oomph::GS< CRDoubleMatrix >::setup_helper | ( | DoubleMatrixBase * | matrix_pt | ) |
Generic setup function to sort out everything that needs to be set up with regards to the input matrix.
Explicit template specialisation of the smoother_setup function for CR matrices. Set up the smoother for the matrix specified by the pointer. This definition of the smoother_setup has the added functionality that it sorts the entries in the given matrix so that the CRDoubleMatrix implementation of the solver can be used.
Definition at line 1435 of file iterative_linear_solver.cc.
References oomph::GS< MATRIX >::Matrix_can_be_deleted, and oomph::GS< MATRIX >::Matrix_pt.
|
inlinevirtual |
Set up the smoother for the matrix specified by the pointer.
Implements oomph::Smoother.
Definition at line 829 of file iterative_linear_solver.h.
References oomph::GS< MATRIX >::Matrix_can_be_deleted.
|
inlinevirtual |
The smoother_solve function performs fixed number of iterations on the system A*result=rhs. The number of (smoothing) iterations is the same as the max. number of iterations in the underlying IterativeLinearSolver class.
Implements oomph::Smoother.
Definition at line 812 of file iterative_linear_solver.h.
References oomph::GS< MATRIX >::Matrix_pt, oomph::GS< MATRIX >::solve_helper(), and oomph::Smoother::Use_as_smoother.
|
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 853 of file iterative_linear_solver.h.
References oomph::DistributableLinearAlgebraObject::build_distribution(), oomph::DistributableLinearAlgebraObject::distribution_pt(), oomph::LinearSolver::Enable_resolve, oomph::GS< MATRIX >::Matrix_can_be_deleted, oomph::GS< MATRIX >::Matrix_pt, oomph::GS< MATRIX >::Resolving, oomph::GS< MATRIX >::solve_helper(), and oomph::Smoother::Use_as_smoother.
|
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 896 of file iterative_linear_solver.h.
References oomph::LinearSolver::solve().
|
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.
//////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////
Explicit template specialisation of the solver for CR matrices: 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 1362 of file iterative_linear_solver.cc.
References oomph::DoubleVector::build(), oomph::DistributableLinearAlgebraObject::build_distribution(), oomph::GS< MATRIX >::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, oomph::GS< MATRIX >::Matrix_can_be_deleted, oomph::GS< MATRIX >::Matrix_pt, oomph::Problem::ndof(), oomph::oomph_info, oomph::GS< MATRIX >::Resolving, oomph::GS< MATRIX >::solve_helper(), oomph::TimingHelpers::timer(), and oomph::Smoother::Use_as_smoother.
|
private |
General interface to solve function.
Explicit template specialisation of the solve_helper function for CR matrices. Exploiting the sparsity of the given matrix allows for a much faster iterative solver.
Definition at line 1480 of file iterative_linear_solver.cc.
References oomph::DoubleVector::build(), oomph::LinearAlgebraDistribution::built(), oomph::CRDoubleMatrix::column_index(), oomph::DistributableLinearAlgebraObject::distribution_pt(), oomph::IterativeLinearSolver::Doc_convergence_history, oomph::LinearSolver::Doc_time, i, oomph::DoubleVector::initialise(), oomph::GS< MATRIX >::Iterations, oomph::IterativeLinearSolver::Max_iter, oomph::DoubleVector::norm(), oomph::DistributableLinearAlgebraObject::nrow(), oomph::oomph_info, oomph::IterativeLinearSolver::Output_file_stream, oomph::DoubleMatrixBase::residual(), oomph::CRDoubleMatrix::row_start(), oomph::IterativeLinearSolver::Solution_time, oomph::Global_string_for_annotation::string(), oomph::IterativeLinearSolver::Throw_error_after_max_iter, oomph::TimingHelpers::timer(), oomph::IterativeLinearSolver::Tolerance, oomph::Smoother::Use_as_smoother, and oomph::CRDoubleMatrix::value().
|
private |
Vector whose i'th entry contains the index of the last entry below or on the diagonal of the i'th row of the matrix.
Definition at line 988 of file iterative_linear_solver.h.
|
private |
Number of iterations taken.
Definition at line 976 of file iterative_linear_solver.h.
|
private |
Boolean flag to indicate if the matrix pointed to be Matrix_pt can be deleted.
Definition at line 984 of file iterative_linear_solver.h.
|
private |
System matrix pointer in the format specified by the template argument.
Definition at line 973 of file iterative_linear_solver.h.
|
private |
Boolean flag to indicate if the solve is done in re-solve mode, bypassing setup of matrix and preconditioner.
Definition at line 980 of file iterative_linear_solver.h.