![]() |
|
#include <complex_smoother.h>
Inheritance diagram for oomph::HelmholtzFGMRESMG< MATRIX >:Public Member Functions | |
| HelmholtzFGMRESMG () | |
| Constructor (empty) More... | |
| virtual | ~HelmholtzFGMRESMG () |
| Destructor (cleanup storage) More... | |
| HelmholtzFGMRESMG (const HelmholtzFGMRESMG &)=delete | |
| Broken copy constructor. More... | |
| void | operator= (const HelmholtzFGMRESMG &)=delete |
| Broken assignment operator. More... | |
| void | set_preconditioner_LHS () |
| void | solve (Problem *const &problem_pt, DoubleVector &result) |
Public Member Functions inherited from oomph::HelmholtzGMRESMG< MATRIX > | |
| HelmholtzGMRESMG () | |
| Constructor. More... | |
| virtual | ~HelmholtzGMRESMG () |
| Destructor (cleanup storage) More... | |
| HelmholtzGMRESMG (const HelmholtzGMRESMG &)=delete | |
| Broken copy constructor. More... | |
| void | operator= (const HelmholtzGMRESMG &)=delete |
| Broken assignment operator. More... | |
| void | disable_resolve () |
| Overload disable resolve so that it cleans up memory too. More... | |
| void | preconditioner_solve (const DoubleVector &r, DoubleVector &z) |
| void | setup () |
| void | solve (DoubleMatrixBase *const &matrix_pt, const DoubleVector &rhs, DoubleVector &solution) |
| void | solve (DoubleMatrixBase *const &matrix_pt, const Vector< double > &rhs, Vector< double > &result) |
| void | resolve (const DoubleVector &rhs, DoubleVector &result) |
| unsigned | iterations () const |
| Number of iterations taken. 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 () | |
| 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="") |
| void | close_convergence_history_file_stream () |
| Close convergence history output stream. More... | |
| double | jacobian_setup_time () const |
| 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 () |
| void | disable_iterative_solver_as_preconditioner () |
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 () |
| virtual void | solve_transpose (Problem *const &problem_pt, DoubleVector &result) |
| virtual void | solve_transpose (DoubleMatrixBase *const &matrix_pt, const DoubleVector &rhs, DoubleVector &result) |
| virtual void | solve_transpose (DoubleMatrixBase *const &matrix_pt, const Vector< double > &rhs, Vector< double > &result) |
| virtual void | resolve_transpose (const DoubleVector &rhs, DoubleVector &result) |
| virtual void | enable_computation_of_gradient () |
| void | disable_computation_of_gradient () |
| void | reset_gradient () |
| 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 |
| void | build_distribution (const LinearAlgebraDistribution *const dist_pt) |
| void | build_distribution (const LinearAlgebraDistribution &dist) |
Public Member Functions inherited from oomph::BlockPreconditioner< MATRIX > | |
| BlockPreconditioner () | |
| Constructor. More... | |
| virtual | ~BlockPreconditioner () |
| Destructor. More... | |
| BlockPreconditioner (const BlockPreconditioner &)=delete | |
| Broken copy constructor. More... | |
| void | operator= (const BlockPreconditioner &)=delete |
| Broken assignment operator. More... | |
| MATRIX * | matrix_pt () const |
| void | turn_on_recursive_debug_flag () |
| void | turn_off_recursive_debug_flag () |
| void | turn_on_debug_flag () |
| Toggles on the debug flag. More... | |
| void | turn_off_debug_flag () |
| Toggles off the debug flag. More... | |
| void | turn_into_subsidiary_block_preconditioner (BlockPreconditioner< MATRIX > *master_block_prec_pt, const Vector< unsigned > &doftype_in_master_preconditioner_coarse) |
| void | turn_into_subsidiary_block_preconditioner (BlockPreconditioner< MATRIX > *master_block_prec_pt, const Vector< unsigned > &doftype_in_master_preconditioner_coarse, const Vector< Vector< unsigned >> &doftype_coarsen_map_coarse) |
| virtual void | block_setup () |
| void | block_setup (const Vector< unsigned > &dof_to_block_map) |
| void | get_block (const unsigned &i, const unsigned &j, MATRIX &output_matrix, const bool &ignore_replacement_block=false) const |
| MATRIX | get_block (const unsigned &i, const unsigned &j, const bool &ignore_replacement_block=false) const |
| void | set_master_matrix_pt (MATRIX *in_matrix_pt) |
| Set the matrix_pt in the upper-most master preconditioner. More... | |
| void | get_block_other_matrix (const unsigned &i, const unsigned &j, MATRIX *in_matrix_pt, MATRIX &output_matrix) |
| void | get_blocks (DenseMatrix< bool > &required_blocks, DenseMatrix< MATRIX * > &block_matrix_pt) const |
| void | get_dof_level_block (const unsigned &i, const unsigned &j, MATRIX &output_block, const bool &ignore_replacement_block=false) const |
| MATRIX | get_concatenated_block (const VectorMatrix< BlockSelector > &selected_block) |
| void | get_concatenated_block_vector (const Vector< unsigned > &block_vec_number, const DoubleVector &v, DoubleVector &b) |
| void | return_concatenated_block_vector (const Vector< unsigned > &block_vec_number, const DoubleVector &b, DoubleVector &v) const |
| Takes concatenated block ordered vector, b, and copies its. More... | |
| void | get_block_vectors (const Vector< unsigned > &block_vec_number, const DoubleVector &v, Vector< DoubleVector > &s) const |
| void | get_block_vectors (const DoubleVector &v, Vector< DoubleVector > &s) const |
| void | return_block_vectors (const Vector< unsigned > &block_vec_number, const Vector< DoubleVector > &s, DoubleVector &v) const |
| void | return_block_vectors (const Vector< DoubleVector > &s, DoubleVector &v) const |
| void | get_block_vector (const unsigned &n, const DoubleVector &v, DoubleVector &b) const |
| void | return_block_vector (const unsigned &n, const DoubleVector &b, DoubleVector &v) const |
| void | get_block_ordered_preconditioner_vector (const DoubleVector &v, DoubleVector &w) |
| void | return_block_ordered_preconditioner_vector (const DoubleVector &w, DoubleVector &v) const |
| unsigned | nblock_types () const |
| Return the number of block types. More... | |
| unsigned | ndof_types () const |
| Return the total number of DOF types. More... | |
| const Mesh * | mesh_pt (const unsigned &i) const |
| unsigned | nmesh () const |
| int | block_number (const unsigned &i_dof) const |
| Return the block number corresponding to a global index i_dof. More... | |
| int | index_in_block (const unsigned &i_dof) const |
| const LinearAlgebraDistribution * | block_distribution_pt (const unsigned &b) const |
| Access function to the block distributions (const version). More... | |
| LinearAlgebraDistribution * | block_distribution_pt (const unsigned b) |
| Access function to the block distributions (non-const version). More... | |
| LinearAlgebraDistribution * | dof_block_distribution_pt (const unsigned &b) |
| Access function to the dof-level block distributions. More... | |
| const LinearAlgebraDistribution * | master_distribution_pt () const |
| unsigned | ndof_types_in_mesh (const unsigned &i) const |
| bool | is_subsidiary_block_preconditioner () const |
| bool | is_master_block_preconditioner () const |
| void | set_block_output_to_files (const std::string &basefilename) |
| void | disable_block_output_to_files () |
| Turn off output of blocks (by clearing the basefilename string). More... | |
| bool | block_output_on () const |
| Test if output of blocks is on or not. More... | |
| void | output_blocks_to_files (const std::string &basefilename, const unsigned &precision=8) const |
| void | post_block_matrix_assembly_partial_clear () |
| BlockPreconditioner< MATRIX > * | master_block_preconditioner_pt () const |
| Access function to the master block preconditioner pt. More... | |
| void | clear_block_preconditioner_base () |
| void | document () |
| Vector< Vector< unsigned > > | doftype_coarsen_map_fine () const |
| Vector< unsigned > | get_fine_grain_dof_types_in (const unsigned &i) const |
| unsigned | nfine_grain_dof_types_in (const unsigned &i) const |
| MapMatrix< unsigned, CRDoubleMatrix * > | replacement_dof_block_pt () const |
| Access function to the replaced dof-level blocks. More... | |
| void | setup_matrix_vector_product (MatrixVectorProduct *matvec_prod_pt, CRDoubleMatrix *block_pt, const Vector< unsigned > &block_col_indices) |
| void | setup_matrix_vector_product (MatrixVectorProduct *matvec_prod_pt, CRDoubleMatrix *block_pt, const unsigned &block_col_index) |
| void | internal_get_block_ordered_preconditioner_vector (const DoubleVector &v, DoubleVector &w) const |
| void | internal_return_block_ordered_preconditioner_vector (const DoubleVector &w, DoubleVector &v) const |
| unsigned | internal_nblock_types () const |
| unsigned | internal_ndof_types () const |
| void | internal_return_block_vector (const unsigned &n, const DoubleVector &b, DoubleVector &v) const |
| void | internal_get_block_vector (const unsigned &n, const DoubleVector &v, DoubleVector &b) const |
| void | internal_get_block_vectors (const Vector< unsigned > &block_vec_number, const DoubleVector &v, Vector< DoubleVector > &s) const |
| void | internal_get_block_vectors (const DoubleVector &v, Vector< DoubleVector > &s) const |
| void | internal_return_block_vectors (const Vector< unsigned > &block_vec_number, const Vector< DoubleVector > &s, DoubleVector &v) const |
| void | internal_return_block_vectors (const Vector< DoubleVector > &s, DoubleVector &v) const |
| void | internal_get_block (const unsigned &i, const unsigned &j, MATRIX &output_block) const |
| int | internal_block_number (const unsigned &i_dof) const |
| int | internal_index_in_block (const unsigned &i_dof) const |
| const LinearAlgebraDistribution * | internal_block_distribution_pt (const unsigned &b) const |
| Access function to the internal block distributions. More... | |
| void | insert_auxiliary_block_distribution (const Vector< unsigned > &block_vec_number, LinearAlgebraDistribution *dist_pt) |
| void | block_matrix_test (const unsigned &i, const unsigned &j, const MATRIX *block_matrix_pt) const |
| template<typename myType > | |
| int | get_index_of_value (const Vector< myType > &vec, const myType val, const bool sorted=false) const |
| void | internal_get_block (const unsigned &block_i, const unsigned &block_j, CRDoubleMatrix &output_block) const |
| void | get_dof_level_block (const unsigned &block_i, const unsigned &block_j, CRDoubleMatrix &output_block, const bool &ignore_replacement_block) const |
Public Member Functions inherited from oomph::Preconditioner | |
| Preconditioner () | |
| Constructor. More... | |
| Preconditioner (const Preconditioner &)=delete | |
| Broken copy constructor. More... | |
| void | operator= (const Preconditioner &)=delete |
| Broken assignment operator. More... | |
| virtual | ~Preconditioner () |
| Destructor (empty) More... | |
| virtual void | preconditioner_solve_transpose (const DoubleVector &r, DoubleVector &z) |
| void | setup (DoubleMatrixBase *matrix_pt) |
| void | setup (const Problem *problem_pt, DoubleMatrixBase *matrix_pt) |
| void | enable_silent_preconditioner_setup () |
| Set up the block preconditioner quietly! More... | |
| void | disable_silent_preconditioner_setup () |
| Be verbose in the block preconditioner setup. More... | |
| virtual void | set_matrix_pt (DoubleMatrixBase *matrix_pt) |
| Set the matrix pointer. More... | |
| virtual const OomphCommunicator * | comm_pt () const |
| Get function for comm pointer. More... | |
| virtual void | set_comm_pt (const OomphCommunicator *const comm_pt) |
| Set the communicator pointer. More... | |
| double | setup_time () const |
| Returns the time to setup the preconditioner. More... | |
| virtual void | turn_into_subsidiary_block_preconditioner (BlockPreconditioner< CRDoubleMatrix > *master_block_prec_pt, const Vector< unsigned > &doftype_in_master_preconditioner_coarse) |
| virtual void | turn_into_subsidiary_block_preconditioner (BlockPreconditioner< CRDoubleMatrix > *master_block_prec_pt, const Vector< unsigned > &doftype_in_master_preconditioner_coarse, const Vector< Vector< unsigned >> &doftype_coarsen_map_coarse) |
Private Member Functions | |
| 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< std::complex< double >>> &hessenberg, const Vector< std::complex< double >> &s, const Vector< Vector< DoubleVector >> &z_m, Vector< DoubleVector > &x) |
| Helper function to update the result vector. More... | |
//////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////// The FGMRES method, i.e. the flexible variant of the GMRES method which allows for nonconstant preconditioners [see Saad Y, "Iterative methods for sparse linear systems", p.287]. Note, FGMRES can only cater to right preconditioning; if the user tries to switch to left preconditioning they will be notified of this
|
inline |
Constructor (empty)
References oomph::HelmholtzGMRESMG< MATRIX >::Preconditioner_LHS.
|
inlinevirtual |
Destructor (cleanup storage)
References oomph::HelmholtzGMRESMG< MATRIX >::clean_up_memory().
|
delete |
Broken copy constructor.
|
delete |
Broken assignment operator.
|
inline |
Overloaded function to let the user know that left preconditioning is not possible with FGMRES, only right preconditioning
References OOMPH_CURRENT_FUNCTION, and OOMPH_EXCEPTION_LOCATION.
|
inlinevirtual |
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.
Reimplemented from oomph::HelmholtzGMRESMG< MATRIX >.
References oomph::BlockPreconditioner< MATRIX >::block_setup(), oomph::DoubleVector::build(), oomph::DistributableLinearAlgebraObject::build_distribution(), oomph::DoubleVector::built(), oomph::HelmholtzGMRESMG< MATRIX >::clean_up_memory(), oomph::MPI_Helpers::communicator_pt(), oomph::Problem::communicator_pt(), oomph::DistributableLinearAlgebraObject::distribution_pt(), oomph::LinearSolver::Doc_time, oomph::LinearSolver::Enable_resolve, f(), oomph::BlockPreconditioner< MATRIX >::get_block(), oomph::Problem::get_jacobian(), i, j, oomph::IterativeLinearSolver::Jacobian_setup_time, oomph::HelmholtzGMRESMG< MATRIX >::Matrices_storage_pt, oomph::HelmholtzGMRESMG< MATRIX >::Matrix_can_be_deleted, oomph::BlockPreconditioner< MATRIX >::matrix_pt(), oomph::Problem::mesh_pt(), oomph::BlockPreconditioner< MATRIX >::nblock_types(), oomph::Problem::ndof(), OOMPH_CURRENT_FUNCTION, OOMPH_EXCEPTION_LOCATION, oomph::oomph_info, oomph::DoubleVector::redistribute(), oomph::HelmholtzGMRESMG< MATRIX >::Resolving, oomph::Preconditioner::set_comm_pt(), oomph::Preconditioner::set_matrix_pt(), oomph::BlockPreconditioner< MATRIX >::set_mesh(), oomph::BlockPreconditioner< MATRIX >::set_nmesh(), oomph::HelmholtzFGMRESMG< MATRIX >::solve_helper(), oomph::TimingHelpers::timer(), and tmp.
|
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++/
References abs(), beta, oomph::DoubleVector::built(), conj(), oomph::LinearAlgebraDistribution::distributed(), oomph::DistributableLinearAlgebraObject::distribution_pt(), hessenberg(), i, Global_Variables::Iterations, j, k, oomph::BlackBoxFDNewtonSolver::Max_iter, oomph::DistributableLinearAlgebraObject::nrow(), OOMPH_CURRENT_FUNCTION, OOMPH_EXCEPTION_LOCATION, oomph::oomph_info, Eigen::bfloat16_impl::pow(), s, BiharmonicTestFunctions1::solution(), sqrt(), oomph::Global_string_for_annotation::string(), oomph::TimingHelpers::timer(), and w.
Referenced by oomph::HelmholtzFGMRESMG< MATRIX >::solve().
|
inlineprivate |
Helper function to update the result vector.
References oomph::DistributableLinearAlgebraObject::distribution_pt(), hessenberg(), i, imag(), j, k, s, plotDoE::x, and y.
Referenced by smc.smc::recursiveBayesian().