| FEAT 3
    Finite Element Analysis Toolbox | 
(Preconditioned) Descent solver implementation More...
#include <descent.hpp>
 
  
| Public Types | |
| typedef PreconditionedIterativeSolver< VectorType > | BaseClass | 
| typedef MatrixType::DataType | DataType | 
| typedef Filter_ | FilterType | 
| typedef Matrix_ | MatrixType | 
| typedef SolverBase< VectorType > | PrecondType | 
| typedef MatrixType::VectorTypeR | VectorType | 
| Public Member Functions | |
| Descent (const MatrixType &matrix, const FilterType &filter, DescentVariant variant, std::shared_ptr< PrecondType > precond=nullptr) | |
| Constructor.  More... | |
| Descent (const String §ion_name, const PropertyMap *section, const MatrixType &matrix, const FilterType &filter, std::shared_ptr< PrecondType > precond=nullptr) | |
| Constructor using a PropertyMap.  More... | |
| virtual Status | apply (Vector_ &vec_cor, const Vector_ &vec_def)=0 | 
| Solver application method.  More... | |
| virtual Status | apply (VectorType &vec_cor, const VectorType &vec_def) override | 
| DataType | calc_convergence_rate () const | 
| Computes the overall convergence rate: (defect_final / defect_initial) ^ (1 / number of iterations)  More... | |
| DataType | calc_defect_reduction () const | 
| Computes the overall defect reduction factor: (defect_final / defect_inital)  More... | |
| virtual Status | correct (VectorType &vec_sol, const VectorType &vec_rhs) override | 
| virtual Status | correct (VectorType &vec_sol, const VectorType &vec_rhs)=0 | 
| Solver correction method.  More... | |
| virtual void | done () | 
| Finalization method.  More... | |
| virtual void | done_numeric () override | 
| virtual void | done_symbolic () override | 
| Symbolic finalization method.   More... | |
| virtual void | force_defect_norm_calc (bool force) | 
| Forces the calculation of defect norms in every iteration.  More... | |
| DataType | get_def_final () const | 
| Returns the final defect.  More... | |
| DataType | get_def_initial () const | 
| Returns the initial defect.  More... | |
| DataType | get_div_abs () const | 
| Returns the absolute divergence.  More... | |
| DataType | get_div_rel () const | 
| Returns the relative divergence.  More... | |
| Index | get_max_iter () const | 
| Returns the maximum number of iterations.  More... | |
| Index | get_min_iter () const | 
| Returns the minimal number of iterations.  More... | |
| Index | get_min_stag_iter () const | 
| Returns the minimum stagnation iteration count.  More... | |
| Index | get_num_iter () const | 
| Returns number of performed iterations.  More... | |
| String | get_plot_name () const | 
| Returns the plot name of the solver.  More... | |
| DataType | get_stag_rate () const | 
| Returns the stagnation rate.  More... | |
| Status | get_status () const | 
| Returns the status.  More... | |
| virtual String | get_summary () const | 
| Returns a summary string.  More... | |
| DataType | get_tol_abs () const | 
| Returns the absolute tolerance.  More... | |
| DataType | get_tol_abs_low () const | 
| Returns the lower absolute tolerance.  More... | |
| DataType | get_tol_rel () const | 
| Returns the relative tolerance.  More... | |
| virtual void | init () | 
| Initialization method.  More... | |
| virtual void | init_numeric () override | 
| virtual void | init_symbolic () override | 
| Symbolic initialization method.   More... | |
| bool | is_converged () const | 
| checks for convergence  More... | |
| bool | is_converged (const DataType def_cur) const | 
| checks for convergence  More... | |
| bool | is_diverged () const | 
| checks for divergence  More... | |
| bool | is_diverged (const DataType def_cur) const | 
| checks for divergence  More... | |
| virtual String | name () const override | 
| Returns a descriptive string.  More... | |
| virtual void | plot_summary () const | 
| Plot a summary of the last solver run.  More... | |
| void | set_div_abs (DataType div_abs) | 
| Sets the absolute divergence for the solver.  More... | |
| void | set_div_rel (DataType div_rel) | 
| Sets the relative divergence for the solver.  More... | |
| void | set_max_iter (Index max_iter) | 
| Sets the maximum iteration count for the solver.  More... | |
| void | set_min_iter (Index min_iter) | 
| Sets the minimum iteration count for the solver.  More... | |
| void | set_min_stag_iter (Index min_iter) | 
| Sets the minimum stagnate iteration count for the solver.  More... | |
| void | set_plot_interval (const Index plot_interval) | 
| Sets the interval between two plot outputs, if any.  More... | |
| void | set_plot_mode (const PlotMode plot_mode) | 
| Sets the plot mode of the solver.  More... | |
| void | set_plot_name (const String &plot_name) | 
| Sets the plot name of the solver.  More... | |
| void | set_stag_rate (DataType rate) | 
| Sets the stagnation rate for the solver.  More... | |
| void | set_tol_abs (DataType tol_abs) | 
| Sets the absolute tolerance for the solver.  More... | |
| void | set_tol_abs_low (DataType tol_abs_low) | 
| Sets the lower absolute tolerance for the solver.  More... | |
| void | set_tol_rel (DataType tol_rel) | 
| Sets the relative tolerance for the solver.  More... | |
| Protected Member Functions | |
| virtual Status | _analyze_defect (Index num_iter, DataType def_cur, DataType def_prev, bool check_stag) | 
| Internal function: analyze the current defect.  More... | |
| virtual Status | _apply_intern (VectorType &vec_sol) | 
| bool | _apply_precond (VectorType &vec_cor, const VectorType &vec_def, const Filter_ &filter) | 
| Applies the preconditioner onto a defect vector.  More... | |
| virtual DataType | _calc_def_norm (const VectorType &vec_def, const VectorType &vec_sol) | 
| Computes the defect norm.  More... | |
| bool | _plot_iter (Status st=Status::progress) const | 
| Plot the current iteration?  More... | |
| virtual void | _plot_iter_line (Index num_iter, DataType def_cur, DataType def_prev) | 
| Plots an iteration line.  More... | |
| bool | _plot_summary () const | 
| Plot summary?  More... | |
| void | _print_line (const String &line) const | 
| Prints a line.  More... | |
| bool | _progress () const | 
| Progress iteration?  More... | |
| void | _set_comm (const Dist::Comm *comm) | 
| Sets the communicator for the solver directly.  More... | |
| template<typename Matrix_ > | |
| void | _set_comm_by_matrix (const Matrix_ &matrix) | 
| Sets the communicator for the solver from a matrix.  More... | |
| void | _set_comm_by_vector (const Vector_ &vector) | 
| Sets the communicator for the solver from a vector.  More... | |
| virtual Status | _set_initial_defect (const VectorType &vec_def, const VectorType &vec_sol) | 
| Internal function: sets the initial defect vector.  More... | |
| virtual Status | _set_new_defect (const VectorType &vec_def, const VectorType &vec_sol) | 
| Internal function: sets the new (next) defect vector.  More... | |
| virtual Status | _update_defect (const DataType def_cur_norm) | 
| Internal function: sets the new (next) defect norm.  More... | |
| Protected Attributes | |
| const Dist::Comm * | _comm | 
| Communicator of the solver.  More... | |
| DataType | _def_cur | 
| current defect  More... | |
| DataType | _def_init | 
| initial defect  More... | |
| DataType | _def_prev | 
| previous iteration defect  More... | |
| DataType | _div_abs | 
| absolute divergence parameter  More... | |
| DataType | _div_rel | 
| relative divergence parameter  More... | |
| bool | _force_def_norm_calc | 
| whether skipping of defect computation is allowed or not  More... | |
| Index | _iter_digits | 
| iteration count digits for plotting  More... | |
| Index | _max_iter | 
| maximum number of iterations  More... | |
| Index | _min_iter | 
| minimum number of iterations  More... | |
| Index | _min_stag_iter | 
| minimum number of stagnation iterations  More... | |
| Index | _num_iter | 
| number of performed iterations  More... | |
| Index | _num_stag_iter | 
| number of consecutive stagnated iterations  More... | |
| Index | _plot_interval | 
| plot output interval  More... | |
| PlotMode | _plot_mode | 
| whether to plot something  More... | |
| String | _plot_name | 
| name of the solver in plots  More... | |
| std::shared_ptr< PrecondType > | _precond | 
| the pointer to the preconditioner  More... | |
| DataType | _stag_rate | 
| stagnation rate  More... | |
| Status | _status | 
| current status of the solver  More... | |
| const FilterType & | _system_filter | 
| the filter for the solver  More... | |
| const MatrixType & | _system_matrix | 
| the matrix for the solver  More... | |
| DataType | _tol_abs | 
| absolute tolerance parameter  More... | |
| DataType | _tol_abs_low | 
| absolute low tolerance parameter  More... | |
| DataType | _tol_rel | 
| relative tolerance parameter  More... | |
| DescentVariant | _variant | 
| the chosen descent type  More... | |
| VectorType | _vec_p | 
| VectorType | _vec_q | 
| VectorType | _vec_r | 
| temporary vectors  More... | |
(Preconditioned) Descent solver implementation
| Matrix_ | The matrix class to be used by the solver. | 
| Filter_ | The filter class to be used by the solver. | 
Definition at line 63 of file descent.hpp.
| typedef PreconditionedIterativeSolver<VectorType> FEAT::Solver::Descent< Matrix_, Filter_ >::BaseClass | 
Definition at line 71 of file descent.hpp.
| typedef MatrixType::DataType FEAT::Solver::Descent< Matrix_, Filter_ >::DataType | 
Definition at line 70 of file descent.hpp.
| typedef Filter_ FEAT::Solver::Descent< Matrix_, Filter_ >::FilterType | 
Definition at line 68 of file descent.hpp.
| typedef Matrix_ FEAT::Solver::Descent< Matrix_, Filter_ >::MatrixType | 
Definition at line 67 of file descent.hpp.
| typedef SolverBase<VectorType> FEAT::Solver::Descent< Matrix_, Filter_ >::PrecondType | 
Definition at line 73 of file descent.hpp.
| typedef MatrixType::VectorTypeR FEAT::Solver::Descent< Matrix_, Filter_ >::VectorType | 
Definition at line 69 of file descent.hpp.
| 
 | inlineexplicit | 
Constructor.
| [in] | matrix | A reference to the system matrix. | 
| [in] | filter | A reference to the system filter. | 
| [in] | variant | The descent variant to use | 
| [in] | precond | A pointer to the preconditioner. May be nullptr. | 
Definition at line 101 of file descent.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_set_comm_by_matrix(), FEAT::Solver::IterativeSolver< Vector_ >::set_plot_name(), and FEAT::stringify().
| 
 | inlineexplicit | 
Constructor using a PropertyMap.
| [in] | section_name | The name of the config section, which it does not know by itself | 
| [in] | section | A pointer to the PropertyMap section configuring this solver | 
| [in] | matrix | The system matrix. | 
| [in] | filter | The system filter. | 
| [in] | precond | The preconditioner. May be nullptr. | 
Definition at line 134 of file descent.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_set_comm_by_matrix(), FEAT::Solver::defect, FEAT::PropertyMap::query(), FEAT::Solver::IterativeSolver< Vector_ >::set_plot_name(), FEAT::Solver::steepest, and FEAT::stringify().
| 
 | inlineprotectedvirtualinherited | 
Internal function: analyze the current defect.
| [in] | num_iter | Current number of iterations; usually = this->_num_iter. | 
| [in] | def_cur | Current defect norm; usually = this->_def_cur. | 
| [in] | def_prev | Previous defect norm; usually = this->_def_prev. | 
| [in] | check_stag | Specifies whether to check (and update) the stagnation criterion. This is typically set to falseif one wants to check anything else than the 'true' next defect norm. | 
Definition at line 866 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_min_iter, FEAT::Solver::aborted, FEAT::Solver::diverged, FEAT::Solver::IterativeSolver< Vector_ >::is_converged(), FEAT::Solver::IterativeSolver< Vector_ >::is_diverged(), FEAT::Math::isfinite(), FEAT::Solver::max_iter, FEAT::Solver::progress, FEAT::Solver::stagnated, and FEAT::Solver::success.
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::_set_new_defect(), and FEAT::Solver::IterativeSolver< Vector_ >::_update_defect().
| 
 | inlineprotectedvirtual | 
Definition at line 217 of file descent.hpp.
| 
 | inlineprotectedinherited | 
Applies the preconditioner onto a defect vector.
| [in,out] | vec_cor | A reference to the vector that shall receive the preconditioned defect. | 
| [in] | vec_def | A reference to the vector that is to be preconditioned. | 
| [in] | filter | A reference to the system filter. This filter is only used if no preconditioner is present. | 
true, if the preconditioner application was successful, otherwise false. Definition at line 1140 of file iterative.hpp.
| 
 | inlineprotectedvirtualinherited | 
Computes the defect norm.
| [in] | vec_def | The current defect vector. | 
| [in] | vec_sol | The current solution vector approximation. | 
Definition at line 706 of file iterative.hpp.
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::_set_initial_defect(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_initial_defect(), FEAT::Solver::IterativeSolver< Vector_ >::_set_new_defect(), and FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_new_defect().
| 
 | inlineprotectedinherited | 
Plot the current iteration?
| [in] | st | The status of the current iteration. | 
true if the plot mode is set to iter or all and the plot interval matches or the solver does not continue to the next iteration Definition at line 720 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_num_iter, FEAT::Solver::IterativeSolver< Vector_ >::_plot_interval, FEAT::Solver::IterativeSolver< Vector_ >::_plot_mode, FEAT::Solver::all, FEAT::Solver::iter, and FEAT::Solver::progress.
Referenced by FEAT::Solver::RBiCGStab< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::BiCGStab< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::IterativeSolver< Vector_ >::_set_initial_defect(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_initial_defect(), FEAT::Solver::IterativeSolver< Vector_ >::_set_new_defect(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_new_defect(), and FEAT::Solver::IterativeSolver< Vector_ >::_update_defect().
| 
 | inlineprotectedvirtualinherited | 
Plots an iteration line.
| [in] | num_iter | Current number of iterations; usually = this->_num_iter. | 
| [in] | def_cur | Current defect norm; usually = this->_def_cur. | 
| [in] | def_prev | Previous defect norm; usually = this->_def_prev. | 
Definition at line 773 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_print_line(), FEAT::String::pad_front(), FEAT::stringify(), FEAT::stringify_fp_fix(), and FEAT::stringify_fp_sci().
Referenced by FEAT::Solver::RBiCGStab< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::BiCGStab< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::IterativeSolver< Vector_ >::_set_initial_defect(), FEAT::Solver::IterativeSolver< Vector_ >::_set_new_defect(), and FEAT::Solver::IterativeSolver< Vector_ >::_update_defect().
| 
 | inlineprotectedinherited | 
Plot summary?
true if the plot mode is set to summary or all. Definition at line 731 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_plot_mode, FEAT::Solver::all, and FEAT::Solver::summary.
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::_set_initial_defect(), FEAT::Solver::IterativeSolver< Vector_ >::_set_new_defect(), and FEAT::Solver::IterativeSolver< Vector_ >::plot_summary().
| 
 | inlineprotectedinherited | 
Prints a line.
| [in] | line | The line to be printed. | 
Definition at line 752 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_comm, and FEAT::Dist::Comm::print().
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::_plot_iter_line(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_initial_defect(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_new_defect(), and FEAT::Solver::IterativeSolver< Vector_ >::plot_summary().
| 
 | inlineprotectedinherited | 
Progress iteration?
true if the solver should process, otherwise false. Definition at line 741 of file iterative.hpp.
References FEAT::Solver::progress.
| 
 | inlineprotectedinherited | 
Sets the communicator for the solver directly.
| [in] | comm | A pointer to the communicator that is to be used by the solver. | 
Definition at line 667 of file iterative.hpp.
| 
 | inlineprotectedinherited | 
Sets the communicator for the solver from a matrix.
| [in] | matrix | A reference to a matrix. If 'Matrix_' is a 'Global::Matrix', then the communicator of the matrix gate is taken. | 
Definition at line 680 of file iterative.hpp.
Referenced by FEAT::Solver::BiCGStab< Matrix_, Filter_ >::BiCGStab(), FEAT::Solver::BiCGStabL< Matrix_, Filter_ >::BiCGStabL(), FEAT::Solver::Descent< Matrix_, Filter_ >::Descent(), FEAT::Solver::FGMRES< Matrix_, Filter_ >::FGMRES(), FEAT::Solver::GMRES< Matrix_, Filter_ >::GMRES(), FEAT::Solver::GroppPCG< Matrix_, Filter_ >::GroppPCG(), FEAT::Solver::IDRS< Matrix_, Filter_ >::IDRS(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::NLOptLS(), FEAT::Solver::PCG< Matrix_, Filter_ >::PCG(), FEAT::Solver::PCR< Matrix_, Filter_ >::PCR(), FEAT::Solver::PipePCG< Matrix_, Filter_ >::PipePCG(), FEAT::Solver::PMR< Matrix_, Filter_ >::PMR(), FEAT::Solver::PSD< Matrix_, Filter_ >::PSD(), FEAT::Solver::RBiCGStab< Matrix_, Filter_ >::RBiCGStab(), FEAT::Solver::RGCR< Matrix_, Filter_ >::RGCR(), and FEAT::Solver::Richardson< Matrix_, Filter_ >::Richardson().
| 
 | inlineprotectedinherited | 
Sets the communicator for the solver from a vector.
| [in] | vector | A reference to a vector. If 'Vector_' is a 'Global::Vector', then the communicator of the vector gate is taken. | 
Definition at line 692 of file iterative.hpp.
| 
 | inlineprotectedvirtualinherited | 
Internal function: sets the initial defect vector.
| [in] | vec_def | The initial defect vector. | 
| [in] | vec_sol | The current solution vector approximation. | 
Reimplemented in FEAT::Solver::QPenalty< Functional_ >.
Definition at line 802 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_calc_def_norm(), FEAT::Solver::IterativeSolver< Vector_ >::_force_def_norm_calc, FEAT::Solver::IterativeSolver< Vector_ >::_max_iter, FEAT::Solver::IterativeSolver< Vector_ >::_plot_iter(), FEAT::Solver::IterativeSolver< Vector_ >::_plot_iter_line(), FEAT::Solver::IterativeSolver< Vector_ >::_plot_summary(), FEAT::Solver::IterativeSolver< Vector_ >::_tol_abs_low, FEAT::Solver::aborted, FEAT::Solver::IterativeSolver< Vector_ >::get_num_iter(), FEAT::Math::isfinite(), FEAT::Solver::SolverBase< Vector_ >::name(), FEAT::Solver::progress, FEAT::Math::sqr(), and FEAT::Solver::success.
Referenced by FEAT::Solver::PCG< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::PCR< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::PipePCG< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::RBiCGStab< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::BiCGStab< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::BiCGStabL< Matrix_, Filter_ >::_apply_intern(), and FEAT::Solver::GroppPCG< Matrix_, Filter_ >::_apply_intern().
| 
 | inlineprotectedvirtualinherited | 
Internal function: sets the new (next) defect vector.
This function computes the defect vector's norm, increments the iteration count, plots an output line to std::cout and checks whether any of the stopping criterions is fulfilled.
| [in] | vec_def | The new defect vector. | 
| [in] | vec_sol | The current solution vector approximation. | 
Definition at line 924 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_analyze_defect(), FEAT::Solver::IterativeSolver< Vector_ >::_calc_def_norm(), FEAT::Solver::IterativeSolver< Vector_ >::_def_cur, FEAT::Solver::IterativeSolver< Vector_ >::_force_def_norm_calc, FEAT::Solver::IterativeSolver< Vector_ >::_max_iter, FEAT::Solver::IterativeSolver< Vector_ >::_num_iter, FEAT::Solver::IterativeSolver< Vector_ >::_plot_iter(), FEAT::Solver::IterativeSolver< Vector_ >::_plot_iter_line(), FEAT::Solver::IterativeSolver< Vector_ >::_plot_summary(), FEAT::Solver::IterativeSolver< Vector_ >::get_num_iter(), and FEAT::Solver::SolverBase< Vector_ >::name().
Referenced by FEAT::Solver::PCG< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::PCR< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::BiCGStab< Matrix_, Filter_ >::_apply_intern(), and FEAT::Solver::BiCGStabL< Matrix_, Filter_ >::_apply_intern().
| 
 | inlineprotectedvirtualinherited | 
Internal function: sets the new (next) defect norm.
This function takes a pre-calculated defect vector norm, increments the iteration count, plots an output line to std::cout and checks whether any of the stopping criterions is fulfilled.
| [in] | def_cur_norm | The new defect norm. | 
Definition at line 970 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_analyze_defect(), FEAT::Solver::IterativeSolver< Vector_ >::_def_cur, FEAT::Solver::IterativeSolver< Vector_ >::_num_iter, FEAT::Solver::IterativeSolver< Vector_ >::_plot_iter(), FEAT::Solver::IterativeSolver< Vector_ >::_plot_iter_line(), FEAT::Solver::IterativeSolver< Vector_ >::get_num_iter(), and FEAT::Solver::SolverBase< Vector_ >::name().
Referenced by FEAT::Solver::PipePCG< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::RBiCGStab< Matrix_, Filter_ >::_apply_intern(), and FEAT::Solver::GroppPCG< Matrix_, Filter_ >::_apply_intern().
| 
 | pure virtualinherited | 
Solver application method.
This method applies the solver represented by this object onto a given defect vector and returns the corresponding correction vector.
correct() method which corrects an initial solution instead of starting with the null vector.| [out] | vec_cor | The vector that shall receive the solution of the linear system. It is assumed to be allocated, but its numerical contents may be undefined upon calling this method. | 
| [in] | vec_def | The vector that represents the right-hand-side of the linear system to be solved. | 
Implemented in FEAT::Solver::SchwarzPrecond< Global::Vector< LocalVector_, Mirror_ >, Global::Filter< LocalFilter_, Mirror_ > >, FEAT::Solver::CuSolverLU, FEAT::Solver::CuSolverQR, FEAT::Solver::ScalePrecond< Vector_, Filter_ >, FEAT::Solver::DiagonalPrecond< Vector_, Filter_ >, FEAT::Solver::MultiGrid< SystemMatrix_, SystemFilter_, TransferOperator_ >, FEAT::Solver::NLOptPrecond< VectorType_, FilterType_ >, FEAT::Solver::AmaVanka< Matrix_, Filter_ >, FEAT::Solver::ConvertPrecond< VectorOuter_, VectorInner_ >, FEAT::Solver::ConvertPrecond< Global::Vector< LocalVectorOuter_, MirrorOuter_ >, Global::Vector< LocalVectorInner_, MirrorInner_ > >, and FEAT::Solver::BFBT< MatrixA_, MatrixB_, MatrixD_, FilterV_, FilterP_ >.
Referenced by FEAT::Solver::solve().
| 
 | inlineoverridevirtual | 
Definition at line 182 of file descent.hpp.
| 
 | inlineinherited | 
Computes the overall convergence rate: (defect_final / defect_initial) ^ (1 / number of iterations)
Definition at line 582 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_def_cur, FEAT::Solver::IterativeSolver< Vector_ >::_def_init, FEAT::Solver::IterativeSolver< Vector_ >::_num_iter, and FEAT::Math::pow().
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::get_summary().
| 
 | inlineinherited | 
Computes the overall defect reduction factor: (defect_final / defect_inital)
Definition at line 597 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_def_init, and FEAT::Math::abs().
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::get_summary().
| 
 | inlineoverridevirtual | 
Definition at line 200 of file descent.hpp.
| 
 | pure virtualinherited | 
Solver correction method.
This method applies the solver represented by this object onto a given right-hand-side vector and updates the corresponding solution vector.
In contrast to the apply() method of the SolverBase base class, this method uses the vector vec_sol as the initial solution vector for the iterative solution process instead of ignoring its contents upon entry and starting with the null vector.
| [in,out] | vec_sol | The vector that contains the initial solution upon entry and receives the solution of the linear system upon exit. | 
| [in] | vec_rhs | The vector that represents the right-hand-side of the linear system to be solved. | 
Implemented in FEAT::Solver::FixedStepLinesearch< Functional_, Filter_ >, FEAT::Solver::MQCLinesearch< Functional_, Filter_ >, FEAT::Solver::NewtonRaphsonLinesearch< Functional_, Filter_ >, FEAT::Solver::SecantLinesearch< Functional_, Filter_ >, and FEAT::Solver::QPenalty< Functional_ >.
Referenced by FEAT::Solver::solve().
| 
 | inlinevirtualinherited | 
Finalization method.
This function performs both the symbolic and numeric finalization, i.e. it simply performs
this->done_numeric(); this->done_symbolic();
Definition at line 283 of file base.hpp.
References FEAT::Solver::SolverBase< Vector_ >::done_numeric(), and FEAT::Solver::SolverBase< Vector_ >::done_symbolic().
| 
 | inlineoverridevirtualinherited | 
Numeric finalization method.
This method is called to release any data allocated in the numeric initialization step.
Reimplemented from FEAT::Solver::SolverBase< Vector_ >.
Definition at line 1102 of file iterative.hpp.
| 
 | inlineoverridevirtual | 
Symbolic finalization method.
This method is called to release any data allocated in the symbolic initialization step.
Reimplemented from FEAT::Solver::PreconditionedIterativeSolver< Matrix_::VectorTypeR >.
Definition at line 173 of file descent.hpp.
References FEAT::Solver::PreconditionedIterativeSolver< Vector_ >::done_symbolic().
| 
 | inlinevirtualinherited | 
Forces the calculation of defect norms in every iteration.
| [in] | force | Specifies whether defect norm computation is to be enforced in every iteration | 
Reimplemented in FEAT::Solver::BiCGStab< Matrix_, Filter_ >, FEAT::Solver::BiCGStabL< Matrix_, Filter_ >, FEAT::Solver::FGMRES< Matrix_, Filter_ >, FEAT::Solver::GMRES< Matrix_, Filter_ >, and FEAT::Solver::RBiCGStab< Matrix_, Filter_ >.
Definition at line 490 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_force_def_norm_calc.
| 
 | inlineinherited | 
Returns the final defect.
Definition at line 570 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_def_cur.
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::get_summary().
| 
 | inlineinherited | 
Returns the initial defect.
Definition at line 564 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_def_init.
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::get_summary().
| 
 | inlineinherited | 
Returns the absolute divergence.
Definition at line 419 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_div_abs.
| 
 | inlineinherited | 
Returns the relative divergence.
Definition at line 413 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_div_rel.
| 
 | inlineinherited | 
Returns the maximum number of iterations.
Definition at line 474 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_max_iter.
| 
 | inlineinherited | 
Returns the minimal number of iterations.
Definition at line 468 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_min_iter.
| 
 | inlineinherited | 
Returns the minimum stagnation iteration count.
Definition at line 443 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_min_stag_iter.
| 
 | inlineinherited | 
Returns number of performed iterations.
Definition at line 462 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_num_iter.
Referenced by FEAT::Solver::ALGLIBMinLBFGS< Functional_, Filter_ >::_apply_intern(), FEAT::Solver::ALGLIBMinCG< Functional_, Filter_ >::_apply_intern(), FEAT::Solver::NLCG< Functional_, Filter_ >::_apply_intern(), FEAT::Solver::NLSD< Functional_, Filter_ >::_apply_intern(), FEAT::Solver::PCG< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::PCR< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::PipePCG< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::RBiCGStab< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::BiCGStab< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::BiCGStabL< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::GroppPCG< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::IterativeSolver< Vector_ >::_set_initial_defect(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_initial_defect(), FEAT::Solver::IterativeSolver< Vector_ >::_set_new_defect(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_new_defect(), FEAT::Solver::IterativeSolver< Vector_ >::_update_defect(), FEAT::Solver::IterativeSolver< Vector_ >::get_summary(), and FEAT::Solver::NLOptLS< Functional_, Filter_ >::get_summary().
| 
 | inlineinherited | 
Returns the plot name of the solver.
Definition at line 523 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_plot_name.
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::get_summary(), and FEAT::Solver::NLOptLS< Functional_, Filter_ >::get_summary().
| 
 | inlineinherited | 
Returns the stagnation rate.
Definition at line 431 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_stag_rate.
| 
 | inlineinherited | 
Returns the status.
Definition at line 576 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_status.
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::get_summary(), and FEAT::Solver::NLOptLS< Functional_, Filter_ >::get_summary().
| 
 | inlinevirtualinherited | 
Returns a summary string.
Reimplemented in FEAT::Solver::Linesearch< Functional_, Filter_ >, and FEAT::Solver::NLOptLS< Functional_, Filter_ >.
Definition at line 610 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::calc_convergence_rate(), FEAT::Solver::IterativeSolver< Vector_ >::calc_defect_reduction(), FEAT::Solver::IterativeSolver< Vector_ >::get_def_final(), FEAT::Solver::IterativeSolver< Vector_ >::get_def_initial(), FEAT::Solver::IterativeSolver< Vector_ >::get_num_iter(), FEAT::Solver::IterativeSolver< Vector_ >::get_plot_name(), FEAT::Solver::IterativeSolver< Vector_ >::get_status(), FEAT::stringify(), FEAT::stringify_fp_fix(), and FEAT::stringify_fp_sci().
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::plot_summary().
| 
 | inlineinherited | 
Returns the absolute tolerance.
Definition at line 389 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_tol_abs.
| 
 | inlineinherited | 
Returns the lower absolute tolerance.
Definition at line 395 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_tol_abs_low.
| 
 | inlineinherited | 
Returns the relative tolerance.
Definition at line 383 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_tol_rel.
| 
 | inlinevirtualinherited | 
Initialization method.
This function performs both the symbolic and numeric initialization, i.e. it simply performs
this->init_symbolic(); this->init_numeric();
Definition at line 268 of file base.hpp.
References FEAT::Solver::SolverBase< Vector_ >::init_numeric(), and FEAT::Solver::SolverBase< Vector_ >::init_symbolic().
| 
 | inlineoverridevirtualinherited | 
Numeric initialization method.
This method is called to perform numeric initialization of the solver.
Before this function can be called, the symbolic initialization must be performed.  
Reimplemented from FEAT::Solver::SolverBase< Vector_ >.
Definition at line 1094 of file iterative.hpp.
| 
 | inlineoverridevirtual | 
Symbolic initialization method.
This method is called to perform symbolic initialization of the solver.
Reimplemented from FEAT::Solver::PreconditionedIterativeSolver< Matrix_::VectorTypeR >.
Definition at line 163 of file descent.hpp.
References FEAT::Solver::Descent< Matrix_, Filter_ >::_vec_r, and FEAT::Solver::PreconditionedIterativeSolver< Vector_ >::init_symbolic().
| 
 | inlineinherited | 
checks for convergence
true, if converged, else false Definition at line 533 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_def_cur, and FEAT::Solver::IterativeSolver< Vector_ >::is_converged().
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::_analyze_defect(), FEAT::Solver::RBiCGStab< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::BiCGStab< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_new_defect(), and FEAT::Solver::IterativeSolver< Vector_ >::is_converged().
| 
 | inlineinherited | 
checks for convergence
| [in] | def_cur | The defect norm that is to be analyzed | 
true, if converged, else false Definition at line 546 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_def_init, FEAT::Solver::IterativeSolver< Vector_ >::_tol_abs, FEAT::Solver::IterativeSolver< Vector_ >::_tol_abs_low, and FEAT::Solver::IterativeSolver< Vector_ >::_tol_rel.
| 
 | inlineinherited | 
checks for divergence
Definition at line 552 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_def_cur, and FEAT::Solver::IterativeSolver< Vector_ >::is_diverged().
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::_analyze_defect(), FEAT::Solver::RBiCGStab< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::BiCGStab< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_new_defect(), and FEAT::Solver::IterativeSolver< Vector_ >::is_diverged().
| 
 | inlineinherited | 
checks for divergence
Definition at line 558 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_def_init, FEAT::Solver::IterativeSolver< Vector_ >::_div_abs, and FEAT::Solver::IterativeSolver< Vector_ >::_div_rel.
| 
 | inlineoverridevirtual | 
Returns a descriptive string.
Implements FEAT::Solver::SolverBase< Vector_ >.
Definition at line 158 of file descent.hpp.
| 
 | inlinevirtualinherited | 
Plot a summary of the last solver run.
Definition at line 627 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_plot_summary(), FEAT::Solver::IterativeSolver< Vector_ >::_print_line(), and FEAT::Solver::IterativeSolver< Vector_ >::get_summary().
Referenced by FEAT::Solver::ALGLIBMinLBFGS< Functional_, Filter_ >::apply(), FEAT::Solver::ALGLIBMinCG< Functional_, Filter_ >::apply(), FEAT::Solver::BiCGStab< Matrix_, Filter_ >::apply(), FEAT::Solver::BiCGStabL< Matrix_, Filter_ >::apply(), FEAT::Solver::NLCG< Functional_, Filter_ >::apply(), FEAT::Solver::NLSD< Functional_, Filter_ >::apply(), FEAT::Solver::PCG< Matrix_, Filter_ >::apply(), FEAT::Solver::RBiCGStab< Matrix_, Filter_ >::apply(), FEAT::Solver::FGMRES< Matrix_, Filter_ >::apply(), FEAT::Solver::GMRES< Matrix_, Filter_ >::apply(), FEAT::Solver::IDRS< Matrix_, Filter_ >::apply(), FEAT::Solver::ALGLIBMinLBFGS< Functional_, Filter_ >::correct(), FEAT::Solver::ALGLIBMinCG< Functional_, Filter_ >::correct(), FEAT::Solver::BiCGStab< Matrix_, Filter_ >::correct(), FEAT::Solver::BiCGStabL< Matrix_, Filter_ >::correct(), FEAT::Solver::FGMRES< Matrix_, Filter_ >::correct(), FEAT::Solver::GMRES< Matrix_, Filter_ >::correct(), FEAT::Solver::IDRS< Matrix_, Filter_ >::correct(), FEAT::Solver::NLCG< Functional_, Filter_ >::correct(), FEAT::Solver::NLSD< Functional_, Filter_ >::correct(), FEAT::Solver::PCG< Matrix_, Filter_ >::correct(), and FEAT::Solver::RBiCGStab< Matrix_, Filter_ >::correct().
| 
 | inlineinherited | 
Sets the absolute divergence for the solver.
Definition at line 407 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_div_abs.
| 
 | inlineinherited | 
Sets the relative divergence for the solver.
Definition at line 401 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_div_rel.
| 
 | inlineinherited | 
Sets the maximum iteration count for the solver.
Definition at line 455 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_iter_digits, FEAT::Solver::IterativeSolver< Vector_ >::_max_iter, FEAT::Math::ilog10(), and FEAT::Solver::max_iter.
Referenced by FEAT::Solver::ALGLIBMinLBFGS< Functional_, Filter_ >::set_max_iter(), and FEAT::Solver::ALGLIBMinCG< Functional_, Filter_ >::set_max_iter().
| 
 | inlineinherited | 
Sets the minimum iteration count for the solver.
Definition at line 449 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_min_iter.
| 
 | inlineinherited | 
Sets the minimum stagnate iteration count for the solver.
Definition at line 437 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_min_stag_iter.
| 
 | inlineinherited | 
Sets the interval between two plot outputs, if any.
| [in] | plot_interval | The desired interval of iteration plots | 
Definition at line 511 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_plot_interval.
| 
 | inlineinherited | 
Sets the plot mode of the solver.
| [in] | plot_mode | The desired plot mode | 
Definition at line 501 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_plot_mode.
| 
 | inlineinherited | 
Sets the plot name of the solver.
Definition at line 517 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_plot_name.
Referenced by FEAT::Solver::BiCGStabL< Matrix_, Filter_ >::BiCGStabL(), and FEAT::Solver::Descent< Matrix_, Filter_ >::Descent().
| 
 | inlineinherited | 
Sets the stagnation rate for the solver.
Definition at line 425 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_stag_rate.
| 
 | inlineinherited | 
Sets the absolute tolerance for the solver.
Definition at line 371 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_tol_abs.
Referenced by FEAT::Solver::ALGLIBMinLBFGS< Functional_, Filter_ >::set_tol_abs(), and FEAT::Solver::ALGLIBMinCG< Functional_, Filter_ >::set_tol_abs().
| 
 | inlineinherited | 
Sets the lower absolute tolerance for the solver.
Definition at line 377 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_tol_abs_low.
| 
 | inlineinherited | 
Sets the relative tolerance for the solver.
Definition at line 365 of file iterative.hpp.
References FEAT::Solver::IterativeSolver< Vector_ >::_tol_rel.
| 
 | protectedinherited | 
Communicator of the solver.
Definition at line 209 of file iterative.hpp.
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::_print_line().
| 
 | protectedinherited | 
current defect
Definition at line 239 of file iterative.hpp.
Referenced by FEAT::Solver::RBiCGStab< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::BiCGStab< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_initial_defect(), FEAT::Solver::IterativeSolver< Vector_ >::_set_new_defect(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_new_defect(), FEAT::Solver::IterativeSolver< Vector_ >::_update_defect(), FEAT::Solver::IterativeSolver< Vector_ >::calc_convergence_rate(), FEAT::Solver::IterativeSolver< Vector_ >::get_def_final(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::get_summary(), FEAT::Solver::IterativeSolver< Vector_ >::is_converged(), and FEAT::Solver::IterativeSolver< Vector_ >::is_diverged().
| 
 | protectedinherited | 
initial defect
Definition at line 237 of file iterative.hpp.
Referenced by FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_initial_defect(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_new_defect(), FEAT::Solver::IterativeSolver< Vector_ >::calc_convergence_rate(), FEAT::Solver::IterativeSolver< Vector_ >::calc_defect_reduction(), FEAT::Solver::IterativeSolver< Vector_ >::get_def_initial(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::get_summary(), FEAT::Solver::IterativeSolver< Vector_ >::is_converged(), and FEAT::Solver::IterativeSolver< Vector_ >::is_diverged().
| 
 | protectedinherited | 
previous iteration defect
Definition at line 241 of file iterative.hpp.
Referenced by FEAT::Solver::RBiCGStab< Matrix_, Filter_ >::_apply_intern(), and FEAT::Solver::BiCGStab< Matrix_, Filter_ >::_apply_intern().
| 
 | protectedinherited | 
absolute divergence parameter
Definition at line 223 of file iterative.hpp.
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::get_div_abs(), FEAT::Solver::IterativeSolver< Vector_ >::is_diverged(), and FEAT::Solver::IterativeSolver< Vector_ >::set_div_abs().
| 
 | protectedinherited | 
relative divergence parameter
Definition at line 221 of file iterative.hpp.
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::get_div_rel(), FEAT::Solver::IterativeSolver< Vector_ >::is_diverged(), and FEAT::Solver::IterativeSolver< Vector_ >::set_div_rel().
| 
 | protectedinherited | 
whether skipping of defect computation is allowed or not
Definition at line 249 of file iterative.hpp.
Referenced by FEAT::Solver::BiCGStab< Matrix_, Filter_ >::BiCGStab(), FEAT::Solver::BiCGStabL< Matrix_, Filter_ >::BiCGStabL(), FEAT::Solver::FGMRES< Matrix_, Filter_ >::FGMRES(), FEAT::Solver::GMRES< Matrix_, Filter_ >::GMRES(), FEAT::Solver::RBiCGStab< Matrix_, Filter_ >::RBiCGStab(), FEAT::Solver::IterativeSolver< Vector_ >::_set_initial_defect(), FEAT::Solver::IterativeSolver< Vector_ >::_set_new_defect(), and FEAT::Solver::IterativeSolver< Vector_ >::force_defect_norm_calc().
| 
 | protectedinherited | 
iteration count digits for plotting
Definition at line 243 of file iterative.hpp.
Referenced by FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_initial_defect(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_new_defect(), and FEAT::Solver::IterativeSolver< Vector_ >::set_max_iter().
| 
 | protectedinherited | 
maximum number of iterations
Definition at line 229 of file iterative.hpp.
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::_set_initial_defect(), FEAT::Solver::IterativeSolver< Vector_ >::_set_new_defect(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_new_defect(), FEAT::Solver::IterativeSolver< Vector_ >::get_max_iter(), FEAT::Solver::ALGLIBMinLBFGS< Functional_, Filter_ >::init_symbolic(), FEAT::Solver::ALGLIBMinCG< Functional_, Filter_ >::init_symbolic(), FEAT::Solver::ALGLIBMinLBFGS< Functional_, Filter_ >::set_max_iter(), FEAT::Solver::ALGLIBMinCG< Functional_, Filter_ >::set_max_iter(), FEAT::Solver::IterativeSolver< Vector_ >::set_max_iter(), FEAT::Solver::ALGLIBMinLBFGS< Functional_, Filter_ >::set_tol_abs(), FEAT::Solver::ALGLIBMinCG< Functional_, Filter_ >::set_tol_abs(), FEAT::Solver::ALGLIBMinLBFGS< Functional_, Filter_ >::set_tol_fval(), and FEAT::Solver::ALGLIBMinCG< Functional_, Filter_ >::set_tol_fval().
| 
 | protectedinherited | 
minimum number of iterations
Definition at line 227 of file iterative.hpp.
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::_analyze_defect(), FEAT::Solver::BiCGStab< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_new_defect(), FEAT::Solver::IterativeSolver< Vector_ >::get_min_iter(), and FEAT::Solver::IterativeSolver< Vector_ >::set_min_iter().
| 
 | protectedinherited | 
minimum number of stagnation iterations
Definition at line 233 of file iterative.hpp.
Referenced by FEAT::Solver::NLCG< Functional_, Filter_ >::NLCG(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_new_defect(), FEAT::Solver::IterativeSolver< Vector_ >::get_min_stag_iter(), and FEAT::Solver::IterativeSolver< Vector_ >::set_min_stag_iter().
| 
 | protectedinherited | 
number of performed iterations
Definition at line 231 of file iterative.hpp.
Referenced by FEAT::Solver::NLCG< Functional_, Filter_ >::_apply_intern(), FEAT::Solver::PipePCG< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::RBiCGStab< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::BiCGStab< Matrix_, Filter_ >::_apply_intern(), FEAT::Solver::IterativeSolver< Vector_ >::_plot_iter(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_initial_defect(), FEAT::Solver::IterativeSolver< Vector_ >::_set_new_defect(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_new_defect(), FEAT::Solver::IterativeSolver< Vector_ >::_update_defect(), FEAT::Solver::IterativeSolver< Vector_ >::calc_convergence_rate(), and FEAT::Solver::IterativeSolver< Vector_ >::get_num_iter().
| 
 | protectedinherited | 
number of consecutive stagnated iterations
Definition at line 235 of file iterative.hpp.
Referenced by FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_initial_defect(), and FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_new_defect().
| 
 | protectedinherited | 
plot output interval
Definition at line 247 of file iterative.hpp.
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::_plot_iter(), and FEAT::Solver::IterativeSolver< Vector_ >::set_plot_interval().
| 
 | protectedinherited | 
whether to plot something
Definition at line 245 of file iterative.hpp.
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::_plot_iter(), FEAT::Solver::IterativeSolver< Vector_ >::_plot_summary(), and FEAT::Solver::IterativeSolver< Vector_ >::set_plot_mode().
| 
 | protectedinherited | 
name of the solver in plots
Definition at line 211 of file iterative.hpp.
Referenced by FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_initial_defect(), FEAT::Solver::NLOptLS< Functional_, Filter_ >::_set_new_defect(), FEAT::Solver::IterativeSolver< Vector_ >::get_plot_name(), and FEAT::Solver::IterativeSolver< Vector_ >::set_plot_name().
| 
 | protectedinherited | 
the pointer to the preconditioner
Definition at line 1040 of file iterative.hpp.
| 
 | protectedinherited | 
stagnation rate
Definition at line 225 of file iterative.hpp.
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::get_stag_rate(), and FEAT::Solver::IterativeSolver< Vector_ >::set_stag_rate().
| 
 | protectedinherited | 
current status of the solver
Definition at line 213 of file iterative.hpp.
Referenced by FEAT::Solver::ALGLIBMinLBFGS< Functional_, Filter_ >::apply(), FEAT::Solver::ALGLIBMinCG< Functional_, Filter_ >::apply(), FEAT::Solver::BiCGStab< Matrix_, Filter_ >::apply(), FEAT::Solver::BiCGStabL< Matrix_, Filter_ >::apply(), FEAT::Solver::NLCG< Functional_, Filter_ >::apply(), FEAT::Solver::NLSD< Functional_, Filter_ >::apply(), FEAT::Solver::PCG< Matrix_, Filter_ >::apply(), FEAT::Solver::RBiCGStab< Matrix_, Filter_ >::apply(), FEAT::Solver::FGMRES< Matrix_, Filter_ >::apply(), FEAT::Solver::GMRES< Matrix_, Filter_ >::apply(), FEAT::Solver::IDRS< Matrix_, Filter_ >::apply(), FEAT::Solver::ALGLIBMinLBFGS< Functional_, Filter_ >::correct(), FEAT::Solver::ALGLIBMinCG< Functional_, Filter_ >::correct(), FEAT::Solver::BiCGStab< Matrix_, Filter_ >::correct(), FEAT::Solver::BiCGStabL< Matrix_, Filter_ >::correct(), FEAT::Solver::FGMRES< Matrix_, Filter_ >::correct(), FEAT::Solver::GMRES< Matrix_, Filter_ >::correct(), FEAT::Solver::IDRS< Matrix_, Filter_ >::correct(), FEAT::Solver::NLCG< Functional_, Filter_ >::correct(), FEAT::Solver::NLSD< Functional_, Filter_ >::correct(), FEAT::Solver::PCG< Matrix_, Filter_ >::correct(), FEAT::Solver::RBiCGStab< Matrix_, Filter_ >::correct(), and FEAT::Solver::IterativeSolver< Vector_ >::get_status().
| 
 | protected | 
the filter for the solver
Definition at line 79 of file descent.hpp.
| 
 | protected | 
the matrix for the solver
Definition at line 77 of file descent.hpp.
| 
 | protectedinherited | 
absolute tolerance parameter
Definition at line 217 of file iterative.hpp.
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::get_tol_abs(), FEAT::Solver::IterativeSolver< Vector_ >::is_converged(), and FEAT::Solver::IterativeSolver< Vector_ >::set_tol_abs().
| 
 | protectedinherited | 
absolute low tolerance parameter
Definition at line 219 of file iterative.hpp.
Referenced by FEAT::Solver::IterativeSolver< Vector_ >::_set_initial_defect(), FEAT::Solver::IterativeSolver< Vector_ >::get_tol_abs_low(), FEAT::Solver::IterativeSolver< Vector_ >::is_converged(), and FEAT::Solver::IterativeSolver< Vector_ >::set_tol_abs_low().
| 
 | protectedinherited | 
relative tolerance parameter
Definition at line 215 of file iterative.hpp.
Referenced by FEAT::Solver::NLCG< Functional_, Filter_ >::_apply_intern(), FEAT::Solver::IterativeSolver< Vector_ >::get_tol_rel(), FEAT::Solver::IterativeSolver< Vector_ >::is_converged(), and FEAT::Solver::IterativeSolver< Vector_ >::set_tol_rel().
| 
 | protected | 
the chosen descent type
Definition at line 83 of file descent.hpp.
| 
 | protected | 
Definition at line 81 of file descent.hpp.
| 
 | protected | 
Definition at line 81 of file descent.hpp.
| 
 | protected | 
temporary vectors
Definition at line 81 of file descent.hpp.
Referenced by FEAT::Solver::Descent< Matrix_, Filter_ >::init_symbolic().