|
ROL
|
This is the complete list of members for ROL::ColemanLiModel< Real >, including all inherited members.
| applyC(Vector< Real > &Cv, const Vector< Real > &v) | ROL::ColemanLiModel< Real > | inlineprivate |
| applyD(Vector< Real > &Dv, const Vector< Real > &v) | ROL::ColemanLiModel< Real > | inlineprivate |
| applyHessian(Vector< Real > &hv, const Vector< Real > &v, Real &tol) | ROL::TrustRegionModel< Real > | inlineprotected |
| applyInverseD(Vector< Real > &Dv, const Vector< Real > &v) | ROL::ColemanLiModel< Real > | inlineprivate |
| applyInvHessian(Vector< Real > &hv, const Vector< Real > &v, Real &tol) | ROL::TrustRegionModel< Real > | inlineprotected |
| applyPrecond(Vector< Real > &Pv, const Vector< Real > &v, Real &tol) | ROL::TrustRegionModel< Real > | inlineprotected |
| cauchyScal_ | ROL::ColemanLiModel< Real > | private |
| cauchyStep_ | ROL::ColemanLiModel< Real > | private |
| checkGradient(const Vector< Real > &x, const Vector< Real > &d, const bool printToStream=true, std::ostream &outStream=std::cout, const int numSteps=ROL_NUM_CHECKDERIV_STEPS, const int order=1) | ROL::Objective< Real > | inlinevirtual |
| checkGradient(const Vector< Real > &x, const Vector< Real > &g, const Vector< Real > &d, const bool printToStream=true, std::ostream &outStream=std::cout, const int numSteps=ROL_NUM_CHECKDERIV_STEPS, const int order=1) | ROL::Objective< Real > | virtual |
| checkGradient(const Vector< Real > &x, const Vector< Real > &d, const std::vector< Real > &steps, const bool printToStream=true, std::ostream &outStream=std::cout, const int order=1) | ROL::Objective< Real > | inlinevirtual |
| checkGradient(const Vector< Real > &x, const Vector< Real > &g, const Vector< Real > &d, const std::vector< Real > &steps, const bool printToStream=true, std::ostream &outStream=std::cout, const int order=1) | ROL::Objective< Real > | virtual |
| checkHessSym(const Vector< Real > &x, const Vector< Real > &v, const Vector< Real > &w, const bool printToStream=true, std::ostream &outStream=std::cout) | ROL::Objective< Real > | inlinevirtual |
| checkHessSym(const Vector< Real > &x, const Vector< Real > &hv, const Vector< Real > &v, const Vector< Real > &w, const bool printToStream=true, std::ostream &outStream=std::cout) | ROL::Objective< Real > | virtual |
| checkHessVec(const Vector< Real > &x, const Vector< Real > &v, const bool printToStream=true, std::ostream &outStream=std::cout, const int numSteps=ROL_NUM_CHECKDERIV_STEPS, const int order=1) | ROL::Objective< Real > | inlinevirtual |
| checkHessVec(const Vector< Real > &x, const Vector< Real > &hv, const Vector< Real > &v, const bool printToStream=true, std::ostream &outStream=std::cout, const int numSteps=ROL_NUM_CHECKDERIV_STEPS, const int order=1) | ROL::Objective< Real > | virtual |
| checkHessVec(const Vector< Real > &x, const Vector< Real > &v, const std::vector< Real > &steps, const bool printToStream=true, std::ostream &outStream=std::cout, const int order=1) | ROL::Objective< Real > | inlinevirtual |
| checkHessVec(const Vector< Real > &x, const Vector< Real > &hv, const Vector< Real > &v, const std::vector< Real > &steps, const bool printToStream=true, std::ostream &outStream=std::cout, const int order=1) | ROL::Objective< Real > | virtual |
| Cmat_ | ROL::ColemanLiModel< Real > | private |
| ColemanLiModel(Objective< Real > &obj, BoundConstraint< Real > &bnd, const Vector< Real > &x, const Vector< Real > &g, const Real stepBackMax=0.9999, const Real stepBackScale=1.0, const bool singleReflect=true, const Ptr< Secant< Real >> &secant=nullPtr, const bool useSecantPrecond=false, const bool useSecantHessVec=false) | ROL::ColemanLiModel< Real > | inline |
| computeAlpha(const Vector< Real > &d) | ROL::ColemanLiModel< Real > | inlineprivate |
| computeCauchyPoint(void) | ROL::ColemanLiModel< Real > | inlineprivate |
| computeFullReflectiveStep(Vector< Real > &Rv, const Vector< Real > &v, const Vector< Real > &Dv) | ROL::ColemanLiModel< Real > | inlineprivate |
| computeReflectiveStep(Vector< Real > &Rv, const Vector< Real > &v, const Vector< Real > &Dv) | ROL::ColemanLiModel< Real > | inlineprivate |
| constructC(void) | ROL::ColemanLiModel< Real > | inlineprivate |
| constructInverseD(void) | ROL::ColemanLiModel< Real > | inlineprivate |
| dirDeriv(const Vector< Real > &x, const Vector< Real > &d, Real &tol) | ROL::Objective< Real > | virtual |
| div_ | ROL::ColemanLiModel< Real > | private |
| Dmat_ | ROL::ColemanLiModel< Real > | private |
| dual_ | ROL::ColemanLiModel< Real > | private |
| dualTransform(Vector< Real > &tv, const Vector< Real > &v) | ROL::ColemanLiModel< Real > | inlinevirtual |
| getBoundConstraint(void) const | ROL::TrustRegionModel< Real > | inlinevirtual |
| getGradient(void) const | ROL::TrustRegionModel< Real > | inlinevirtual |
| getIterate(void) const | ROL::TrustRegionModel< Real > | inlinevirtual |
| getObjective(void) const | ROL::TrustRegionModel< Real > | inlinevirtual |
| getParameter(void) const | ROL::Objective< Real > | inlineprotected |
| getScalarBounds(Real &lowerBound, Real &upperBound, const Vector< Real > &p) | ROL::ColemanLiModel< Real > | inlineprivate |
| gradient(Vector< Real > &g, const Vector< Real > &s, Real &tol) | ROL::ColemanLiModel< Real > | inlinevirtual |
| hessVec(Vector< Real > &hv, const Vector< Real > &v, const Vector< Real > &s, Real &tol) | ROL::ColemanLiModel< Real > | inlinevirtual |
| hv_ | ROL::ColemanLiModel< Real > | private |
| initialize(const Vector< Real > &x, const Vector< Real > &g) | ROL::ColemanLiModel< Real > | inlineprivate |
| invHessVec(Vector< Real > &hv, const Vector< Real > &v, const Vector< Real > &s, Real &tol) | ROL::TrustRegionModel< Real > | inlinevirtual |
| isStrictlyFeasibleStep(const Vector< Real > &d) const | ROL::ColemanLiModel< Real > | inlineprivate |
| lx_ | ROL::ColemanLiModel< Real > | private |
| minimize1D(Real &tau, const Real lowerBound, const Real upperBound, const Vector< Real > &p) | ROL::ColemanLiModel< Real > | inlineprivate |
| mult_ | ROL::ColemanLiModel< Real > | private |
| precond(Vector< Real > &Pv, const Vector< Real > &v, const Vector< Real > &s, Real &tol) | ROL::TrustRegionModel< Real > | inlinevirtual |
| pred_ | ROL::ColemanLiModel< Real > | private |
| prim_ | ROL::ColemanLiModel< Real > | private |
| primalTransform(Vector< Real > &tiv, const Vector< Real > &v) | ROL::ColemanLiModel< Real > | inlinevirtual |
| reflectScal_ | ROL::ColemanLiModel< Real > | private |
| reflectStep_ | ROL::ColemanLiModel< Real > | private |
| sCs_ | ROL::ColemanLiModel< Real > | private |
| setParameter(const std::vector< Real > ¶m) | ROL::Objective< Real > | inlinevirtual |
| setRadius(const Real del) | ROL::ColemanLiModel< Real > | inline |
| singleReflect_ | ROL::ColemanLiModel< Real > | private |
| step_ | ROL::ColemanLiModel< Real > | private |
| stepBackMax_ | ROL::ColemanLiModel< Real > | private |
| stepBackScale_ | ROL::ColemanLiModel< Real > | private |
| TRradius_ | ROL::ColemanLiModel< Real > | private |
| TrustRegionModel(Objective< Real > &obj, BoundConstraint< Real > &bnd, const Vector< Real > &x, const Vector< Real > &g, const Ptr< Secant< Real >> &secant=nullPtr, const bool useSecantPrecond=false, const bool useSecantHessVec=false) | ROL::TrustRegionModel< Real > | inline |
| update(Objective< Real > &obj, BoundConstraint< Real > &bnd, const Vector< Real > &x, const Vector< Real > &g, const Ptr< Secant< Real >> &secant=nullPtr) | ROL::ColemanLiModel< Real > | inlinevirtual |
| ROL::Objective::update(const Vector< Real > &x, bool flag=true, int iter=-1) | ROL::Objective< Real > | inlinevirtual |
| updateActualReduction(Real &ared, const Vector< Real > &s) | ROL::ColemanLiModel< Real > | inlinevirtual |
| updatePredictedReduction(Real &pred, const Vector< Real > &s) | ROL::ColemanLiModel< Real > | inlinevirtual |
| ux_ | ROL::ColemanLiModel< Real > | private |
| value(const Vector< Real > &s, Real &tol) | ROL::ColemanLiModel< Real > | inlinevirtual |
| ~Objective() | ROL::Objective< Real > | inlinevirtual |
| ~TrustRegionModel() | ROL::TrustRegionModel< Real > | inlinevirtual |
1.8.5