44 #ifndef ROL_PARAMETRIZED_COMPOSITE_OBJECTIVE_H
45 #define ROL_PARAMETRIZED_COMPOSITE_OBJECTIVE_H
60 const std::vector<Teuchos::RCP<ParametrizedObjective<Real> > >
obj_vec_;
61 const Teuchos::RCP<ParametrizedStdObjective<Real> >
std_obj_;
74 for (
int i = 0; i < size; ++i) {
86 for (
int i = 0; i < size; ++i) {
87 (*obj_value_)[i] =
obj_vec_[i]->value(x,tol);
98 for (
int i = 0; i < size; ++i) {
108 for (
int i = 0; i < size; ++i) {
133 for (
int i = 0; i < size; ++i) {
143 for (
int i = 0; i < size; ++i) {
159 for (
int i = 0; i < size; ++i) {
168 for (
int i = 0; i < size; ++i) {
void computeValue(const Vector< Real > &x, Real &tol)
Teuchos::RCP< std::vector< Real > > obj_hess_
Specializes the ROL::Objective interface for objective functions that operate on ROL::StdVector's.
const Teuchos::RCP< ParametrizedStdObjective< Real > > std_obj_
virtual const Vector & dual() const
Return dual representation of , for example, the result of applying a Riesz map, or change of basis...
Teuchos::RCP< std::vector< Real > > obj_grad_
virtual void axpy(const Real alpha, const Vector &x)
Compute where .
std::vector< Teuchos::RCP< Vector< Real > > > vec_grad_
Teuchos::RCP< std::vector< Real > > obj_value_
Teuchos::RCP< StdVector< Real > > obj_value_vec_
Teuchos::RCP< StdVector< Real > > obj_hess_vec_
virtual void zero()
Set to zero vector.
Defines the linear algebra or vector space interface.
Teuchos::RCP< std::vector< Real > > obj_gv_
void initialize(const Vector< Real > &x)
Teuchos::RCP< StdVector< Real > > obj_gv_vec_
void hessVec(Vector< Real > &hv, const Vector< Real > &v, const Vector< Real > &x, Real &tol)
Apply Hessian approximation to vector.
void computeGradient(const Vector< Real > &x, Real &tol)
const std::vector< Teuchos::RCP< ParametrizedObjective< Real > > > obj_vec_
void update(const Vector< Real > &x, bool flag=true, int iter=-1)
Update objective function.
Teuchos::RCP< StdVector< Real > > obj_grad_vec_
Real value(const Vector< Real > &x, Real &tol)
Compute value.
void computeHessVec(const Vector< Real > &v, const Vector< Real > &x, Real &tol)
ParametrizedCompositeObjective(const std::vector< Teuchos::RCP< ParametrizedObjective< Real > > > &obj_vec, const Teuchos::RCP< ParametrizedStdObjective< Real > > &std_obj)
void setParameter(const std::vector< Real > ¶m)
virtual void setParameter(const std::vector< Real > ¶m)
void gradient(Vector< Real > &g, const Vector< Real > &x, Real &tol)
Compute gradient.
Provides the interface to evaluate parametrized composite objective functions.
std::vector< Teuchos::RCP< Vector< Real > > > vec_hess_