42#ifndef THYRA_NONLINEAR_SOLVER_BASE_HPP
43#define THYRA_NONLINEAR_SOLVER_BASE_HPP
45#include "Thyra_LinearOpWithSolveBase.hpp"
46#include "Thyra_ModelEvaluator.hpp"
47#include "Teuchos_Describable.hpp"
48#include "Teuchos_VerboseObject.hpp"
49#include "Teuchos_ParameterListAcceptor.hpp"
74template <
class Scalar>
224template <
class Scalar>
232 return nonlinearSolver.
solve(x,solveCriteria,delta);
239template <
class Scalar>
245template <
class Scalar>
252template <
class Scalar>
259template <
class Scalar>
265template <
class Scalar>
272template <
class Scalar>
279template <
class Scalar>
283 true, std::logic_error,
284 "Error, the subclass object described as " << this->description() <<
" did not"
285 " override this function!"
Pure abstract base interface for evaluating a stateless "model" that can be mapped into a number of d...
Base class for all nonlinear equation solvers.
virtual void set_W_is_current(bool W_is_current)
Set if *get_W() is current with respect to *get_current_x().
virtual RCP< const VectorBase< Scalar > > get_current_x() const
Return the current value of the solution x as computed in the last solve() operation if supported.
virtual RCP< NonlinearSolverBase< Scalar > > cloneNonlinearSolver() const
Clone the solver algorithm if supported.
virtual RCP< const ModelEvaluator< Scalar > > getModel() const =0
Get the model that defines the nonlinear equations.
virtual SolveStatus< Scalar > solve(VectorBase< Scalar > *x, const SolveCriteria< Scalar > *solveCriteria=NULL, VectorBase< Scalar > *delta=NULL)=0
Solve a set of nonlinear equations from a given starting point.
const SolveStatus< Scalar > solve(NonlinearSolverBase< Scalar > &nonlinearSolver, VectorBase< Scalar > *x, const SolveCriteria< Scalar > *solveCriteria=NULL, VectorBase< Scalar > *delta=NULL)
virtual RCP< LinearOpWithSolveBase< Scalar > > get_nonconst_W(const bool forceUpToDate=false)
Get a nonconst RCP to the Jacobian if available.
virtual RCP< const LinearOpWithSolveBase< Scalar > > get_W() const
Get a const RCP to the Jacobian if available.
virtual void setModel(const RCP< const ModelEvaluator< Scalar > > &model)=0
Set the model that defines the nonlinear equations.
virtual bool is_W_current() const
Returns true if *get_W() is current with respect to *get_current_x().
virtual bool supportsCloning() const
Return if this solver object supports cloning or not.
Abstract interface for finite-dimensional dense vectors.
#define TEUCHOS_TEST_FOR_EXCEPTION(throw_exception_test, Exception, msg)
T_To & dyn_cast(T_From &from)
Simple struct that defines the requested solution criteria for a solve.
Simple struct for the return status from a solve.