44 #ifndef ROL_COMPOSITEOBJECTIVE_SIMOPT_H
45 #define ROL_COMPOSITEOBJECTIVE_SIMOPT_H
61 const std::vector<Teuchos::RCP<ParametrizedObjective_SimOpt<Real> > >
obj_vec_;
62 const Teuchos::RCP<ParametrizedStdObjective<Real> >
std_obj_;
87 for (
int i = 0; i < size; ++i) {
101 for (
int i = 0; i < size; ++i) {
102 (*obj_value_)[i] =
obj_vec_[i]->value(u,z,tol);
120 for (
int i = 0; i < size; ++i) {
131 for (
int i = 0; i < size; ++i) {
141 for (
int i = 0; i < size; ++i) {
152 for (
int i = 0; i < size; ++i) {
163 for (
int i = 0; i < size; ++i) {
173 for (
int i = 0; i < size; ++i) {
200 for (
int i = 0; i < size; ++i) {
212 for (
int i = 0; i < size; ++i) {
231 for (
int i = 0; i < size; ++i) {
240 for (
int i = 0; i < size; ++i) {
250 for (
int i = 0; i < size; ++i) {
261 for (
int i = 0; i < size; ++i) {
272 for (
int i = 0; i < size; ++i) {
283 for (
int i = 0; i < size; ++i) {
Specializes the ROL::Objective interface for objective functions that operate on ROL::StdVector's.
virtual const Vector & dual() const
Return dual representation of , for example, the result of applying a Riesz map, or change of basis...
Teuchos::RCP< StdVector< Real > > obj_value_vec_
void update(const Vector< Real > &u, const Vector< Real > &z, bool flag=true, int iter=-1)
Update objective function. u is an iterate, z is an iterate, flag = true if the iterate has changed...
std::vector< Teuchos::RCP< Vector< Real > > > vec_grad1_
Teuchos::RCP< StdVector< Real > > obj_grad_vec_
virtual void axpy(const Real alpha, const Vector &x)
Compute where .
void computeHessVec22(const Vector< Real > &v, const Vector< Real > &u, const Vector< Real > &z, Real &tol)
std::vector< Teuchos::RCP< Vector< Real > > > vec_hess1_
void computeHessVec21(const Vector< Real > &v, const Vector< Real > &u, const Vector< Real > &z, Real &tol)
void computeGradient(const Vector< Real > &u, const Vector< Real > &z, Real &tol)
void hessVec_21(Vector< Real > &hv, const Vector< Real > &v, const Vector< Real > &u, const Vector< Real > &z, Real &tol)
bool isGradient1Computed_
const std::vector< Teuchos::RCP< ParametrizedObjective_SimOpt< Real > > > obj_vec_
Teuchos::RCP< std::vector< Real > > obj_gv_
void computeHessVec11(const Vector< Real > &v, const Vector< Real > &u, const Vector< Real > &z, Real &tol)
virtual void zero()
Set to zero vector.
Defines the linear algebra or vector space interface.
Real value(const Vector< Real > &u, const Vector< Real > &z, Real &tol)
Compute value.
Teuchos::RCP< std::vector< Real > > obj_hess_
void gradient_2(Vector< Real > &g, const Vector< Real > &u, const Vector< Real > &z, Real &tol)
Compute gradient with respect to second component.
Teuchos::RCP< StdVector< Real > > obj_hess_vec_
void computeGradient2(const Vector< Real > &u, const Vector< Real > &z, Real &tol)
std::vector< Teuchos::RCP< Vector< Real > > > vec_hess2_
void hessVec_12(Vector< Real > &hv, const Vector< Real > &v, const Vector< Real > &u, const Vector< Real > &z, Real &tol)
Teuchos::RCP< std::vector< Real > > obj_grad_
void setParameter(const std::vector< Real > ¶m)
Teuchos::RCP< StdVector< Real > > obj_gv_vec_
Teuchos::RCP< std::vector< Real > > obj_value_
void gradient_1(Vector< Real > &g, const Vector< Real > &u, const Vector< Real > &z, Real &tol)
Compute gradient with respect to first component.
const Teuchos::RCP< ParametrizedStdObjective< Real > > std_obj_
virtual void setParameter(const std::vector< Real > ¶m)
bool isGradient2Computed_
std::vector< Teuchos::RCP< Vector< Real > > > vec_grad2_
void initialize(const Vector< Real > &u, const Vector< Real > &z)
void computeHessVec12(const Vector< Real > &v, const Vector< Real > &u, const Vector< Real > &z, Real &tol)
ParametrizedCompositeObjective_SimOpt(const std::vector< Teuchos::RCP< ParametrizedObjective_SimOpt< Real > > > &obj_vec, const Teuchos::RCP< ParametrizedStdObjective< Real > > &std_obj)
void computeValue(const Vector< Real > &u, const Vector< Real > &z, Real &tol)
void hessVec_11(Vector< Real > &hv, const Vector< Real > &v, const Vector< Real > &u, const Vector< Real > &z, Real &tol)
Apply Hessian approximation to vector.
void computeGradient1(const Vector< Real > &u, const Vector< Real > &z, Real &tol)
void hessVec_22(Vector< Real > &hv, const Vector< Real > &v, const Vector< Real > &u, const Vector< Real > &z, Real &tol)