70 using Teuchos::dyn_cast;
75 using Teuchos::dyn_cast;
86 return -(*xp)[0]*(*xp)[1]*(*xp)[2];
96 (*gp)[0] = -(*xp)[1]*(*xp)[2];
97 (*gp)[1] = -(*xp)[0]*(*xp)[2];
98 (*gp)[2] = -(*xp)[0]*(*xp)[1];
109 (*hvp)[0] = -( (*xp)[2]*(*vp)[1] + (*xp)[1]*(*vp)[2] );
110 (*hvp)[1] = -( (*xp)[2]*(*vp)[0] + (*xp)[0]*(*vp)[2] );
111 (*hvp)[2] = -( (*xp)[1]*(*vp)[0] + (*xp)[0]*(*vp)[1] );
128 using Teuchos::dyn_cast;
133 using Teuchos::dyn_cast;
146 (*cp)[0] = -std::pow((*xp)[0],2) - 2*std::pow((*xp)[1],2) - 4*std::pow((*xp)[2],2) + 48;
159 (*jvp)[0] = -2*(*xp)[0]*(*vp)[0] - 4*(*xp)[1]*(*vp)[1] - 8*(*xp)[2]*(*vp)[2];
172 (*ajvp)[0] = -2*(*xp)[0]*(*vp)[0];
173 (*ajvp)[1] = -4*(*xp)[1]*(*vp)[0];
174 (*ajvp)[2] = -8*(*xp)[2]*(*vp)[0];
188 (*ahuvp)[0] = -2*(*up)[0]*(*vp)[0];
189 (*ahuvp)[1] = -4*(*up)[0]*(*vp)[1];
190 (*ahuvp)[2] = -8*(*up)[0]*(*vp)[2];
200 #endif // ROL_HS29_HPP Provides the interface to evaluate objective functions.
void applyAdjointJacobian(Vector< Real > &ajv, const Vector< Real > &v, const Vector< Real > &x, Real &tol)
Apply the adjoint of the the constraint Jacobian at , , to vector .
void value(Vector< Real > &c, const Vector< Real > &x, Real &tol)
Evaluate the constraint operator at .
Teuchos::RCP< const vector > getVector(const V &x)
std::vector< Real > vector
Defines the linear algebra or vector space interface.
Teuchos::RCP< const vector > getVector(const V &x)
void hessVec(Vector< Real > &hv, const Vector< Real > &v, const Vector< Real > &x, Real &tol)
Apply Hessian approximation to vector.
Real value(const Vector< Real > &x, Real &tol)
Compute value.
void gradient(Vector< Real > &g, const Vector< Real > &x, Real &tol)
Compute gradient.
Teuchos::RCP< vector > getVector(V &x)
Teuchos::RCP< vector > getVector(V &x)
Provides a unique argument for inequality constraints, which otherwise behave exactly as equality con...
void applyJacobian(Vector< Real > &jv, const Vector< Real > &v, const Vector< Real > &x, Real &tol)
Apply the constraint Jacobian at , , to vector .
std::vector< Real > vector
void applyAdjointHessian(Vector< Real > &ahuv, const Vector< Real > &u, const Vector< Real > &v, const Vector< Real > &x, Real &tol)
Apply the derivative of the adjoint of the constraint Jacobian at to vector in direction ...