48 #define ROL_UNUSED(x) (void) x 54 #include "ROL_Elementwise_Function.hpp" 56 #include "ROL_Ptr.hpp" 82 :
public std::enable_shared_from_this<Vector<Real>>
109 virtual void scale(
const Real alpha ) = 0;
119 virtual Real
dot(
const Vector &x )
const = 0;
128 virtual Real
norm()
const = 0;
139 virtual ROL::Ptr<Vector>
clone()
const = 0;
154 ROL::Ptr<Vector> ax = x.
clone();
168 this->
scale( (Real)0 );
182 virtual ROL::Ptr<Vector>
basis(
const int i )
const {
242 virtual void applyUnary(
const Elementwise::UnaryFunction<Real> &f ) {
244 ROL_TEST_FOR_EXCEPTION(
true, std::logic_error,
245 "The method applyUnary wass called, but not implemented" << std::endl);
251 ROL_TEST_FOR_EXCEPTION(
true, std::logic_error,
252 "The method applyBinary wass called, but not implemented" << std::endl);
255 virtual Real
reduce(
const Elementwise::ReductionOp<Real> &r )
const {
257 ROL_TEST_FOR_EXCEPTION(
true, std::logic_error,
258 "The method reduce was called, but not implemented" << std::endl);
261 virtual void print( std::ostream &outStream )
const {
262 outStream <<
"The method print was called, but not implemented" << std::endl;
292 virtual void randomize(
const Real l = 0.0,
const Real u = 1.0 ) {
293 Elementwise::UniformlyRandom<Real> ur(l,u);
327 const bool printToStream =
true,
328 std::ostream & outStream = std::cout )
const {
334 std::vector<Real> vCheck;
338 ROL::Ptr<std::ostream> pStream;
340 pStream = ROL::makePtrFromRef(outStream);
342 pStream = ROL::makePtrFromRef(bhs);
347 oldFormatState.copyfmt(*pStream);
349 ROL::Ptr<Vector> v = this->
clone();
350 ROL::Ptr<Vector> vtmp = this->
clone();
351 ROL::Ptr<Vector> xtmp = x.
clone();
352 ROL::Ptr<Vector> ytmp = y.
clone();
354 *pStream <<
"\n" << std::setw(width) << std::left << std::setfill(
'*') <<
"********** Begin verification of linear algebra. " <<
"\n\n";
355 headerFormatState.copyfmt(*pStream);
358 v->set(*
this); xtmp->set(x); ytmp->set(y);
359 v->plus(x); xtmp->plus(*
this); v->axpy(-one, *xtmp); vCheck.push_back(v->norm());
360 *pStream << std::scientific << std::setprecision(12) << std::setfill('>
'); 361 *pStream << std::setw(width) << std::left << "Commutativity of addition. Consistency error: " << " " << vCheck.back() << "\n"; 363 // Associativity of addition. 364 v->set(*this); xtmp->set(x); ytmp->set(y); 365 ytmp->plus(x); v->plus(*ytmp); xtmp->plus(*this); xtmp->plus(y); v->axpy(-one, *xtmp); vCheck.push_back(v->norm()); 366 *pStream << std::setw(width) << std::left << "Associativity of addition. Consistency error: " << " " << vCheck.back() << "\n"; 368 // Identity element of addition. 369 v->set(*this); xtmp->set(x); ytmp->set(y); 370 v->zero(); v->plus(x); v->axpy(-one, x); vCheck.push_back(v->norm()); 371 *pStream << std::setw(width) << std::left << "Identity element of addition. Consistency error: " << " " << vCheck.back() << "\n"; 373 // Inverse elements of addition. 374 v->set(*this); xtmp->set(x); ytmp->set(y); 375 v->scale(-one); v->plus(*this); vCheck.push_back(v->norm()); 376 *pStream << std::setw(width) << std::left << "Inverse elements of addition. Consistency error: " << " " << vCheck.back() << "\n"; 378 // Identity element of scalar multiplication. 379 v->set(*this); xtmp->set(x); ytmp->set(y); 380 v->scale(one); v->axpy(-one, *this); vCheck.push_back(v->norm()); 381 *pStream << std::setw(width) << std::left << "Identity element of scalar multiplication. Consistency error: " << " " << vCheck.back() << "\n"; 383 // Consistency of scalar multiplication with field multiplication. 384 v->set(*this); vtmp->set(*this); 385 v->scale(b); v->scale(a); vtmp->scale(a*b); v->axpy(-one, *vtmp); vCheck.push_back(v->norm()); 386 *pStream << std::setw(width) << std::left << "Consistency of scalar multiplication with field multiplication. Consistency error: " << " " << vCheck.back() << "\n"; 388 // Distributivity of scalar multiplication with respect to field addition. 389 v->set(*this); vtmp->set(*this); 390 v->scale(a+b); vtmp->scale(a); vtmp->axpy(b, *this); v->axpy(-one, *vtmp); vCheck.push_back(v->norm()); 391 *pStream << std::setw(width) << std::left << "Distributivity of scalar multiplication with respect to field addition. Consistency error: " << " " << vCheck.back() << "\n"; 393 // Distributivity of scalar multiplication with respect to vector addition. 394 v->set(*this); xtmp->set(x); ytmp->set(y); 395 v->plus(x); v->scale(a); xtmp->scale(a); xtmp->axpy(a, *this); v->axpy(-one, *xtmp); vCheck.push_back(v->norm()); 396 *pStream << std::setw(width) << std::left << "Distributivity of scalar multiplication with respect to vector addition. Consistency error: " << " " << vCheck.back() << "\n"; 398 // Commutativity of dot (inner) product over the field of reals. 399 vCheck.push_back(std::abs(this->dot(x) - x.dot(*this))); 400 *pStream << std::setw(width) << std::left << "Commutativity of dot (inner) product over the field of reals. Consistency error: " << " " << vCheck.back() << "\n"; 402 // Additivity of dot (inner) product. 404 xtmp->plus(y); vCheck.push_back(std::abs(this->dot(*xtmp) - this->dot(x) - this->dot(y))/std::max({static_cast<Real>(std::abs(this->dot(*xtmp))), static_cast<Real>(std::abs(this->dot(x))), static_cast<Real>(std::abs(this->dot(y))), one})); 405 *pStream << std::setw(width) << std::left << "Additivity of dot (inner) product. Consistency error: " << " " << vCheck.back() << "\n"; 407 // Consistency of scalar multiplication and norm. 409 Real vnorm = v->norm(); 412 vCheck.push_back(std::abs(v->norm() - zero)); 415 vCheck.push_back(std::abs(v->norm() - one)); 417 *pStream << std::setw(width) << std::left << "Consistency of scalar multiplication and norm. Consistency error: " << " " << vCheck.back() << "\n"; 421 xtmp = ROL::constPtrCast<Vector>(ROL::makePtrFromRef(this->dual())); 422 ytmp = ROL::constPtrCast<Vector>(ROL::makePtrFromRef(xtmp->dual())); 423 v->axpy(-one, *ytmp); vCheck.push_back(v->norm()); 424 *pStream << std::setw(width) << std::left << "Reflexivity. Consistency error: " << " " << vCheck.back() << "\n"; 426 // Consistency of apply and dual. 428 xtmp = x.dual().clone(); xtmp->set(x.dual()); 429 Real vx = v->apply(*xtmp); 430 Real vxd = v->dot(xtmp->dual()); 431 Real vdx = xtmp->dot(v->dual()); 433 vCheck.push_back(std::max(std::abs(vx-vxd),std::abs(vx-vdx))); 436 vCheck.push_back(std::max(std::abs(vx-vxd),std::abs(vx-vdx))/std::abs(vx)); 438 *pStream << std::setw(width) << std::left << "Consistency of apply and dual:" << " " << vCheck.back() << "\n\n"; 440 //*pStream << "************ End verification of linear algebra.\n\n"; 442 // Restore format state of pStream used for the header info. 443 pStream->copyfmt(headerFormatState); 444 *pStream << std::setw(width) << std::left << "********** End verification of linear algebra. " << "\n\n"; 446 // Restore format state of the original pStream. 447 pStream->copyfmt(oldFormatState); virtual void scale(const Real alpha)=0
Compute where .
virtual ROL::Ptr< Vector > clone() const =0
Clone to make a new (uninitialized) vector.
virtual Real apply(const Vector< Real > &x) const
Apply to a dual vector. This is equivalent to the call .
virtual void plus(const Vector &x)=0
Compute , where .
virtual void axpy(const Real alpha, const Vector &x)
Compute where .
basic_nullstream< char, char_traits< char > > nullstream
virtual void applyBinary(const Elementwise::BinaryFunction< Real > &f, const Vector &x)
virtual void randomize(const Real l=0.0, const Real u=1.0)
Set vector to be uniform random between [l,u].
virtual ROL::Ptr< Vector > basis(const int i) const
Return i-th basis vector.
virtual void zero()
Set to zero vector.
Defines the linear algebra or vector space interface.
Defines a no-output stream class ROL::NullStream and a function makeStreamPtr which either wraps a re...
virtual Real dot(const Vector &x) const =0
Compute where .
virtual const Vector & dual() const
Return dual representation of , for example, the result of applying a Riesz map, or change of basis...
virtual int dimension() const
Return dimension of the vector space.
virtual void setScalar(const Real C)
Set where .
virtual void applyUnary(const Elementwise::UnaryFunction< Real > &f)
virtual Real reduce(const Elementwise::ReductionOp< Real > &r) const
virtual std::vector< Real > checkVector(const Vector< Real > &x, const Vector< Real > &y, const bool printToStream=true, std::ostream &outStream=std::cout) const
Verify vector-space methods.
virtual Real norm() const =0
Returns where .
virtual void print(std::ostream &outStream) const