74 Teuchos::RCP<const std::vector<Real> > ex =
78 Real h = 1.0/((Real)(this->
dim_) + 1.0);
79 for (
int i = 0; i < this->
dim_; i++ ) {
80 f = 2.0*(*ex)[i] + h*h*std::pow((*ex)[i] + (Real)(i+1)*h + 1.0,3.0)/2.0;
81 if ( i < (this->dim_-1) ) { f -= (*ex)[i+1]; }
82 if ( i > 0 ) { f -= (*ex)[i-1]; }
89 Teuchos::RCP<const std::vector<Real> > ex =
91 Teuchos::RCP<std::vector<Real> > eg =
92 Teuchos::rcp_const_cast<std::vector<Real> >((Teuchos::dyn_cast<
StdVector<Real> >(g)).getVector());
94 Real h = 1.0/((Real)(this->
dim_) + 1.0);
95 std::vector<Real> f(this->
dim_,0.0);
96 for (
int i = 0; i < this->
dim_; i++ ) {
97 f[i] = 2.0*(*ex)[i] + h*h*std::pow((*ex)[i] + (Real)(i+1)*h + 1.0,3.0)/2.0;
98 if ( i < (this->dim_-1) ) { f[i] -= (*ex)[i+1]; }
99 if ( i > 0) { f[i] -= (*ex)[i-1]; }
102 for (
int i = 0; i < this->
dim_; i++ ) {
103 df = (2.0 + 3.0*h*h*std::pow((*ex)[i] + (Real)(i+1)*h + 1.0,2.0)/2.0)*f[i];
104 if ( i < (this->dim_-1) ) { df -= f[i+1]; }
105 if ( i > 0 ) { df -= f[i-1]; }
111 Teuchos::RCP<const std::vector<Real> > ex =
113 Teuchos::RCP<const std::vector<Real> > ev =
115 Teuchos::RCP<std::vector<Real> > ehv =
116 Teuchos::rcp_const_cast<std::vector<Real> >((Teuchos::dyn_cast<
StdVector<Real> >(hv)).getVector());
118 Real h = 1.0/((Real)(this->
dim_) + 1.0);
119 Real f = 0.0, df = 0.0, dfn = 0.0, hf = 0.0;
120 for (
int i = 0; i < this->
dim_; i++ ) {
121 f = 2.0*(*ex)[i] + h*h*std::pow((*ex)[i] + (Real)(i+1)*h + 1.0,3.0)/2.0;
122 df = 2.0 + 3.0/2.0 * h*h * std::pow((*ex)[i] + (Real)(i+1)*h + 1.0,2.0);
123 hf = 3.0 * h*h * ((*ex)[i] + (Real)(i+1)*h + 1.0);
124 if ( i < (this->dim_-2) ) {
125 (*ehv)[i] += 2.0*(*ev)[i+2];
127 if ( i < (this->dim_-1) ) {
129 dfn = 2.0 + 3.0/2.0 * h*h * std::pow((*ex)[i+1] + (Real)(i+2)*h + 1.0,2.0);
130 (*ehv)[i] -= 2.0*(df + dfn)*(*ev)[i+1];
131 (*ehv)[i] += 2.0*(*ev)[i];
135 dfn = 2.0 + 3.0/2.0 * h*h * std::pow((*ex)[i-1] + (Real)(i)*h + 1.0,2.0);
136 (*ehv)[i] -= 2.0*(df + dfn)*(*ev)[i-1];
137 (*ehv)[i] += 2.0*(*ev)[i];
140 (*ehv)[i] += 2.0*(*ev)[i-2];
142 (*ehv)[i] += 2.0*(hf*f + df*df)*(*ev)[i];
152 Teuchos::RCP<std::vector<Real> > x0p =
153 Teuchos::rcp_const_cast<std::vector<Real> >((Teuchos::dyn_cast<
StdVector<Real> >(x0)).getVector());
154 Teuchos::RCP<std::vector<Real> > xp =
155 Teuchos::rcp_const_cast<std::vector<Real> >((Teuchos::dyn_cast<
StdVector<Real> >(x)).getVector());
164 std::vector<Real> l, u;
165 std::vector<Real> val(n,0.0);
167 val[1] = -0.1*0.4520;
168 val[2] = -0.1*0.6588;
169 val[3] = -0.1*0.8514;
170 val[4] = -0.1*1.0288;
171 val[5] = -0.1*1.1985;
172 val[6] = -0.1*1.3322;
173 val[7] = -0.1*1.4553;
174 val[8] = -0.1*1.5571;
175 val[9] = -0.1*1.6354;
176 val[10] = -0.1*1.6881;
177 val[11] = -0.1*1.7127;
178 val[12] = -0.1*1.7060;
179 val[13] = -0.1*1.6650;
180 val[14] = -0.1*1.5856;
181 val[15] = -0.1*1.4636;
182 val[16] = -0.1*1.2938;
183 val[17] = -0.1*1.0702;
184 val[18] = -0.1*0.7858;
185 val[19] = -0.1*0.4323;
186 for (
int i = 0; i < n; i++ ) {
188 l.push_back(std::max(-0.2*(Real)(n),val[i]+0.1));
189 u.push_back(std::min( 0.2*(Real)(n),val[i]+1.1));
192 l.push_back(-0.2*(Real)(n));
193 u.push_back( 0.2*(Real)(n));
199 Real h = 1.0/((Real)n + 1.0);
200 for (
int i = 0; i < n; i++ ) {
201 (*x0p)[i] = (Real)(i+1)*h*((Real)(i+1)*h - 1.0);
205 (*xp)[0] = 1.2321000000000001e-01;
206 (*xp)[1] = 2.1743122909175336e-01;
207 (*xp)[2] = 2.8625218549543746e-01;
208 (*xp)[3] = 3.3309751851140840e-01;
209 (*xp)[4] = 3.6117201714254760e-01;
210 (*xp)[5] = 3.7342787212179440e-01;
211 (*xp)[6] = 3.7255212003706123e-01;
212 (*xp)[7] = 3.6096984201471016e-01;
213 (*xp)[8] = 3.4085861052124522e-01;
214 (*xp)[9] = 3.1417024791439530e-01;
215 (*xp)[10] = 2.8265678244892922e-01;
216 (*xp)[11] = 2.4789833165179542e-01;
217 (*xp)[12] = 2.1133139591375166e-01;
218 (*xp)[13] = 1.7427666644258599e-01;
219 (*xp)[14] = 1.3796594229036069e-01;
220 (*xp)[15] = 1.0356813245768780e-01;
221 (*xp)[16] = 7.2214621084083663e-02;
222 (*xp)[17] = 4.5024529114833199e-02;
223 (*xp)[18] = 2.3130648161534966e-02;
224 (*xp)[19] = 7.7070870882527927e-03;
Contains definitions for std::vector bound constraints.
Provides the interface to evaluate objective functions.
void gradient(Vector< Real > &g, const Vector< Real > &x, Real &tol)
Compute gradient.
Real value(const Vector< Real > &x, Real &tol)
Compute value.
virtual void hessVec(Vector< Real > &hv, const Vector< Real > &v, const Vector< Real > &x, Real &tol)
Apply Hessian approximation to vector.
virtual void zero()
Set to zero vector.
Defines the linear algebra or vector space interface.
Provides the std::vector implementation of the ROL::Vector interface.
void getBVP(Teuchos::RCP< Objective< Real > > &obj, Teuchos::RCP< BoundConstraint< Real > > &con, Vector< Real > &x0, Vector< Real > &x)
The discrete boundary value problem.
Provides the interface to apply upper and lower bound constraints.