diff --git a/packages/rol/src/algorithm/TypeB/ROL_TypeB_Algorithm.hpp b/packages/rol/src/algorithm/TypeB/ROL_TypeB_Algorithm.hpp index f5fad2d9f574..1ec94b8e695f 100644 --- a/packages/rol/src/algorithm/TypeB/ROL_TypeB_Algorithm.hpp +++ b/packages/rol/src/algorithm/TypeB/ROL_TypeB_Algorithm.hpp @@ -224,7 +224,7 @@ class Algorithm { /** \brief Print iterate status. */ - virtual void writeOutput( std::ostream& os, bool write_header = false ) const; + virtual void writeOutput( std::ostream& os, const bool write_header = false ) const; virtual void writeExitStatus( std::ostream& os ) const; diff --git a/packages/rol/src/algorithm/TypeB/ROL_TypeB_ColemanLiAlgorithm.hpp b/packages/rol/src/algorithm/TypeB/ROL_TypeB_ColemanLiAlgorithm.hpp index 4527d2588c5e..3b1f917d1f48 100644 --- a/packages/rol/src/algorithm/TypeB/ROL_TypeB_ColemanLiAlgorithm.hpp +++ b/packages/rol/src/algorithm/TypeB/ROL_TypeB_ColemanLiAlgorithm.hpp @@ -124,7 +124,7 @@ class ColemanLiAlgorithm : public TypeB::Algorithm { void writeName( std::ostream& os ) const override; - void writeOutput( std::ostream& os, bool write_header = false ) const override; + void writeOutput( std::ostream& os, const bool write_header = false ) const override; private: void initialize(Vector &x, diff --git a/packages/rol/src/algorithm/TypeB/ROL_TypeB_GradientAlgorithm.hpp b/packages/rol/src/algorithm/TypeB/ROL_TypeB_GradientAlgorithm.hpp index e3f4487729db..ee03819a026c 100644 --- a/packages/rol/src/algorithm/TypeB/ROL_TypeB_GradientAlgorithm.hpp +++ b/packages/rol/src/algorithm/TypeB/ROL_TypeB_GradientAlgorithm.hpp @@ -87,7 +87,7 @@ class GradientAlgorithm : public TypeB::Algorithm { void writeName( std::ostream& os ) const override; - void writeOutput( std::ostream& os, bool write_header = false ) const override; + void writeOutput( std::ostream& os, const bool write_header = false ) const override; }; // class ROL::TypeB::GradientAlgorithm diff --git a/packages/rol/src/algorithm/TypeB/ROL_TypeB_InteriorPointAlgorithm.hpp b/packages/rol/src/algorithm/TypeB/ROL_TypeB_InteriorPointAlgorithm.hpp index 5669239f30a9..fa24aaa20895 100644 --- a/packages/rol/src/algorithm/TypeB/ROL_TypeB_InteriorPointAlgorithm.hpp +++ b/packages/rol/src/algorithm/TypeB/ROL_TypeB_InteriorPointAlgorithm.hpp @@ -112,7 +112,7 @@ class InteriorPointAlgorithm : public TypeB::Algorithm { void writeName( std::ostream& os ) const override; - void writeOutput( std::ostream& os, bool write_header = false ) const override; + void writeOutput( std::ostream& os, const bool write_header = false ) const override; }; // class ROL::TypeB::InteriorPointAlgorithm diff --git a/packages/rol/src/algorithm/TypeB/ROL_TypeB_KelleySachsAlgorithm.hpp b/packages/rol/src/algorithm/TypeB/ROL_TypeB_KelleySachsAlgorithm.hpp index 6af146dfcd2f..e2333e3a1b10 100644 --- a/packages/rol/src/algorithm/TypeB/ROL_TypeB_KelleySachsAlgorithm.hpp +++ b/packages/rol/src/algorithm/TypeB/ROL_TypeB_KelleySachsAlgorithm.hpp @@ -130,7 +130,7 @@ class KelleySachsAlgorithm : public TypeB::Algorithm { void writeName( std::ostream& os ) const override; - void writeOutput( std::ostream& os, bool write_header = false ) const override; + void writeOutput( std::ostream& os, const bool write_header = false ) const override; private: void initialize(Vector &x, diff --git a/packages/rol/src/algorithm/TypeB/ROL_TypeB_LSecantBAlgorithm.hpp b/packages/rol/src/algorithm/TypeB/ROL_TypeB_LSecantBAlgorithm.hpp index 0787479278ab..a427b3ef6d8a 100644 --- a/packages/rol/src/algorithm/TypeB/ROL_TypeB_LSecantBAlgorithm.hpp +++ b/packages/rol/src/algorithm/TypeB/ROL_TypeB_LSecantBAlgorithm.hpp @@ -112,7 +112,7 @@ class LSecantBAlgorithm : public TypeB::Algorithm { void writeName( std::ostream& os ) const override; - void writeOutput( std::ostream& os, bool write_header = false ) const override; + void writeOutput( std::ostream& os, const bool write_header = false ) const override; private: void initialize(Vector &x, diff --git a/packages/rol/src/algorithm/TypeB/ROL_TypeB_LinMoreAlgorithm.hpp b/packages/rol/src/algorithm/TypeB/ROL_TypeB_LinMoreAlgorithm.hpp index 044a96f73a86..d93895f85b07 100644 --- a/packages/rol/src/algorithm/TypeB/ROL_TypeB_LinMoreAlgorithm.hpp +++ b/packages/rol/src/algorithm/TypeB/ROL_TypeB_LinMoreAlgorithm.hpp @@ -144,7 +144,7 @@ class LinMoreAlgorithm : public TypeB::Algorithm { void writeName( std::ostream& os ) const override; - void writeOutput( std::ostream& os, bool write_header = false ) const override; + void writeOutput( std::ostream& os, const bool write_header = false ) const override; private: void initialize(Vector &x, diff --git a/packages/rol/src/algorithm/TypeB/ROL_TypeB_MoreauYosidaAlgorithm.hpp b/packages/rol/src/algorithm/TypeB/ROL_TypeB_MoreauYosidaAlgorithm.hpp index b28574daae76..78de9edc1489 100644 --- a/packages/rol/src/algorithm/TypeB/ROL_TypeB_MoreauYosidaAlgorithm.hpp +++ b/packages/rol/src/algorithm/TypeB/ROL_TypeB_MoreauYosidaAlgorithm.hpp @@ -108,7 +108,7 @@ class MoreauYosidaAlgorithm : public TypeB::Algorithm { void writeName( std::ostream& os ) const override; - void writeOutput( std::ostream& os, bool write_header = false ) const override; + void writeOutput( std::ostream& os, const bool write_header = false ) const override; }; // class ROL::TypeB::MoreauYosidaAlgorithm diff --git a/packages/rol/src/algorithm/TypeB/ROL_TypeB_NewtonKrylovAlgorithm.hpp b/packages/rol/src/algorithm/TypeB/ROL_TypeB_NewtonKrylovAlgorithm.hpp index 686c3e3b96c0..aa880c24a3ac 100644 --- a/packages/rol/src/algorithm/TypeB/ROL_TypeB_NewtonKrylovAlgorithm.hpp +++ b/packages/rol/src/algorithm/TypeB/ROL_TypeB_NewtonKrylovAlgorithm.hpp @@ -195,7 +195,7 @@ class NewtonKrylovAlgorithm : public TypeB::Algorithm { void writeName( std::ostream& os ) const override; - void writeOutput( std::ostream& os, bool write_header = false ) const override; + void writeOutput( std::ostream& os, const bool write_header = false ) const override; }; // class ROL::TypeB::NewtonKrylovAlgorithm diff --git a/packages/rol/src/algorithm/TypeB/ROL_TypeB_PrimalDualActiveSetAlgorithm.hpp b/packages/rol/src/algorithm/TypeB/ROL_TypeB_PrimalDualActiveSetAlgorithm.hpp index 29708719af86..c648439f8f3c 100644 --- a/packages/rol/src/algorithm/TypeB/ROL_TypeB_PrimalDualActiveSetAlgorithm.hpp +++ b/packages/rol/src/algorithm/TypeB/ROL_TypeB_PrimalDualActiveSetAlgorithm.hpp @@ -258,7 +258,7 @@ class PrimalDualActiveSetAlgorithm : public TypeB::Algorithm { void writeName( std::ostream& os ) const override; - void writeOutput( std::ostream& os, bool write_header = false ) const override; + void writeOutput( std::ostream& os, const bool write_header = false ) const override; }; // class ROL::TypeB::PrimalDualActiveSetAlgorithm diff --git a/packages/rol/src/algorithm/TypeB/ROL_TypeB_QuasiNewtonAlgorithm.hpp b/packages/rol/src/algorithm/TypeB/ROL_TypeB_QuasiNewtonAlgorithm.hpp index 884f5decb5ac..822e59e81f9d 100644 --- a/packages/rol/src/algorithm/TypeB/ROL_TypeB_QuasiNewtonAlgorithm.hpp +++ b/packages/rol/src/algorithm/TypeB/ROL_TypeB_QuasiNewtonAlgorithm.hpp @@ -104,7 +104,7 @@ class QuasiNewtonAlgorithm : public TypeB::Algorithm { void writeName( std::ostream& os ) const override; - void writeOutput( std::ostream &os, bool write_header = false ) const override; + void writeOutput( std::ostream &os, const bool write_header = false ) const override; }; // class ROL::TypeB::QuasiNewtonAlgorithm diff --git a/packages/rol/src/algorithm/TypeB/ROL_TypeB_SpectralGradientAlgorithm.hpp b/packages/rol/src/algorithm/TypeB/ROL_TypeB_SpectralGradientAlgorithm.hpp index 605693ec808a..e04f481d9b58 100644 --- a/packages/rol/src/algorithm/TypeB/ROL_TypeB_SpectralGradientAlgorithm.hpp +++ b/packages/rol/src/algorithm/TypeB/ROL_TypeB_SpectralGradientAlgorithm.hpp @@ -86,7 +86,7 @@ class SpectralGradientAlgorithm : public TypeB::Algorithm { void writeName( std::ostream &os ) const override; - void writeOutput( std::ostream &os, bool write_header = false ) const override; + void writeOutput( std::ostream &os, const bool write_header = false ) const override; }; // class ROL::TypeB::SpectralGradientAlgorithm diff --git a/packages/rol/src/algorithm/TypeB/ROL_TypeB_TrustRegionSPGAlgorithm.hpp b/packages/rol/src/algorithm/TypeB/ROL_TypeB_TrustRegionSPGAlgorithm.hpp index 0b4968f57c83..bcc0cac4bb69 100644 --- a/packages/rol/src/algorithm/TypeB/ROL_TypeB_TrustRegionSPGAlgorithm.hpp +++ b/packages/rol/src/algorithm/TypeB/ROL_TypeB_TrustRegionSPGAlgorithm.hpp @@ -140,7 +140,7 @@ class TrustRegionSPGAlgorithm : public TypeB::Algorithm { void writeName( std::ostream& os ) const override; - void writeOutput( std::ostream& os, bool write_header = false ) const override; + void writeOutput( std::ostream& os, const bool write_header = false ) const override; private: void initialize(Vector &x, diff --git a/packages/rol/src/algorithm/TypeE/ROL_TypeE_Algorithm.hpp b/packages/rol/src/algorithm/TypeE/ROL_TypeE_Algorithm.hpp index 18393662ace8..49fd832411d3 100644 --- a/packages/rol/src/algorithm/TypeE/ROL_TypeE_Algorithm.hpp +++ b/packages/rol/src/algorithm/TypeE/ROL_TypeE_Algorithm.hpp @@ -172,7 +172,7 @@ class Algorithm { /** \brief Print iterate status. */ - virtual void writeOutput( std::ostream& os, bool write_header = false ) const; + virtual void writeOutput( std::ostream& os, const bool write_header = false ) const; virtual void writeExitStatus( std::ostream& os ) const; diff --git a/packages/rol/src/algorithm/TypeG/ROL_TypeG_Algorithm.hpp b/packages/rol/src/algorithm/TypeG/ROL_TypeG_Algorithm.hpp index cc440a0a07f2..666cfe3bd60e 100644 --- a/packages/rol/src/algorithm/TypeG/ROL_TypeG_Algorithm.hpp +++ b/packages/rol/src/algorithm/TypeG/ROL_TypeG_Algorithm.hpp @@ -405,7 +405,7 @@ class Algorithm { /** \brief Print iterate status. */ - virtual void writeOutput( std::ostream& os, bool write_header = false ) const; + virtual void writeOutput( std::ostream& os, const bool write_header = false ) const; virtual void writeExitStatus( std::ostream& os ) const; diff --git a/packages/rol/src/algorithm/TypeG/augmentedlagrangian/ROL_AugmentedLagrangianObjective.hpp b/packages/rol/src/algorithm/TypeG/augmentedlagrangian/ROL_AugmentedLagrangianObjective.hpp index 19c352ab154b..9f077e3200c0 100644 --- a/packages/rol/src/algorithm/TypeG/augmentedlagrangian/ROL_AugmentedLagrangianObjective.hpp +++ b/packages/rol/src/algorithm/TypeG/augmentedlagrangian/ROL_AugmentedLagrangianObjective.hpp @@ -51,6 +51,7 @@ #include "ROL_Types.hpp" #include "ROL_Ptr.hpp" #include "ROL_ScalarController.hpp" +#include "ROL_ParameterList.hpp" #include /** @ingroup func_group diff --git a/packages/rol/src/algorithm/TypeG/fletcher/ROL_FletcherObjectiveBase_Def.hpp b/packages/rol/src/algorithm/TypeG/fletcher/ROL_FletcherObjectiveBase_Def.hpp index 3321ff35c179..be11ff750ac2 100644 --- a/packages/rol/src/algorithm/TypeG/fletcher/ROL_FletcherObjectiveBase_Def.hpp +++ b/packages/rol/src/algorithm/TypeG/fletcher/ROL_FletcherObjectiveBase_Def.hpp @@ -140,7 +140,7 @@ template Ptr> FletcherObjectiveBase::getGradient(const Vector& x) { // TODO: Figure out reasonable tolerance Real tol = static_cast(1e-12); - gradient(*xdual_, x, tol); + this->gradient(*xdual_, x, tol); return xdual_; } diff --git a/packages/rol/src/algorithm/TypeG/moreauyosida/ROL_MoreauYosidaObjective.hpp b/packages/rol/src/algorithm/TypeG/moreauyosida/ROL_MoreauYosidaObjective.hpp index ddf68a92ad55..c22642f3b831 100644 --- a/packages/rol/src/algorithm/TypeG/moreauyosida/ROL_MoreauYosidaObjective.hpp +++ b/packages/rol/src/algorithm/TypeG/moreauyosida/ROL_MoreauYosidaObjective.hpp @@ -50,6 +50,7 @@ #include "ROL_Types.hpp" #include "ROL_Ptr.hpp" #include "ROL_ScalarController.hpp" +#include "ROL_ParameterList.hpp" #include /** @ingroup func_group diff --git a/packages/rol/src/algorithm/TypeU/ROL_TypeU_Algorithm.hpp b/packages/rol/src/algorithm/TypeU/ROL_TypeU_Algorithm.hpp index f69954574e40..7240787ae02b 100644 --- a/packages/rol/src/algorithm/TypeU/ROL_TypeU_Algorithm.hpp +++ b/packages/rol/src/algorithm/TypeU/ROL_TypeU_Algorithm.hpp @@ -154,7 +154,7 @@ class Algorithm { /** \brief Print iterate status. */ - virtual void writeOutput( std::ostream& os, bool write_header = false ) const; + virtual void writeOutput( std::ostream& os, const bool write_header = false ) const; virtual void writeExitStatus( std::ostream& os ) const; diff --git a/packages/rol/src/algorithm/TypeU/ROL_TypeU_BundleAlgorithm.hpp b/packages/rol/src/algorithm/TypeU/ROL_TypeU_BundleAlgorithm.hpp index ad76539bd2b0..2fa88bd07f56 100644 --- a/packages/rol/src/algorithm/TypeU/ROL_TypeU_BundleAlgorithm.hpp +++ b/packages/rol/src/algorithm/TypeU/ROL_TypeU_BundleAlgorithm.hpp @@ -108,7 +108,7 @@ class BundleAlgorithm : public Algorithm { void writeName( std::ostream& os) const override; - void writeOutput( std::ostream& os, bool print_header = false ) const override; + void writeOutput( std::ostream& os, const bool print_header = false ) const override; private: diff --git a/packages/rol/src/algorithm/TypeU/ROL_TypeU_LineSearchAlgorithm.hpp b/packages/rol/src/algorithm/TypeU/ROL_TypeU_LineSearchAlgorithm.hpp index ed81db4a60f7..8e5cf1764963 100644 --- a/packages/rol/src/algorithm/TypeU/ROL_TypeU_LineSearchAlgorithm.hpp +++ b/packages/rol/src/algorithm/TypeU/ROL_TypeU_LineSearchAlgorithm.hpp @@ -153,7 +153,7 @@ class LineSearchAlgorithm : public Algorithm { void writeName( std::ostream& os ) const override; - void writeOutput( std::ostream& os, bool print_header = false ) const override; + void writeOutput( std::ostream& os, const bool print_header = false ) const override; }; // class ROL::TypeU::LineSearchAlgorithm diff --git a/packages/rol/src/algorithm/TypeU/ROL_TypeU_TrustRegionAlgorithm.hpp b/packages/rol/src/algorithm/TypeU/ROL_TypeU_TrustRegionAlgorithm.hpp index 252d1d971468..bf7bdba09bf8 100644 --- a/packages/rol/src/algorithm/TypeU/ROL_TypeU_TrustRegionAlgorithm.hpp +++ b/packages/rol/src/algorithm/TypeU/ROL_TypeU_TrustRegionAlgorithm.hpp @@ -118,7 +118,7 @@ class TrustRegionAlgorithm : public Algorithm { void writeName( std::ostream& os ) const override; - void writeOutput( std::ostream& os, bool print_header = false ) const override; + void writeOutput( std::ostream& os, const bool print_header = false ) const override; private: diff --git a/packages/rol/src/algorithm/TypeU/linesearch/descent/ROL_DescentDirection_U_Factory.hpp b/packages/rol/src/algorithm/TypeU/linesearch/descent/ROL_DescentDirection_U_Factory.hpp index d754edf8e450..9b1cb2f881e8 100644 --- a/packages/rol/src/algorithm/TypeU/linesearch/descent/ROL_DescentDirection_U_Factory.hpp +++ b/packages/rol/src/algorithm/TypeU/linesearch/descent/ROL_DescentDirection_U_Factory.hpp @@ -49,6 +49,7 @@ #include "ROL_NonlinearCG_U.hpp" #include "ROL_Newton_U.hpp" #include "ROL_NewtonKrylov_U.hpp" +#include "ROL_LineSearch_U_Types.hpp" namespace ROL { template diff --git a/packages/rol/src/elementwise/ROL_Elementwise_Function.hpp b/packages/rol/src/elementwise/ROL_Elementwise_Function.hpp index e385f5f6dc51..77f3f67110a4 100644 --- a/packages/rol/src/elementwise/ROL_Elementwise_Function.hpp +++ b/packages/rol/src/elementwise/ROL_Elementwise_Function.hpp @@ -41,6 +41,10 @@ // ************************************************************************ // @HEADER +#ifndef ROL_VECTOR_H +#include "ROL_Vector.hpp" +#else + #ifndef ROL_ELEMENTWISE_FUNCTION_H #define ROL_ELEMENTWISE_FUNCTION_H @@ -132,3 +136,4 @@ void applyBinaryInPlace(ROL::Vector &x, const ROL::Vector &y, Func f #include #endif +#endif diff --git a/packages/rol/src/elementwise/ROL_Elementwise_Reduce.hpp b/packages/rol/src/elementwise/ROL_Elementwise_Reduce.hpp index 29f28be408b0..ec91a146de0b 100644 --- a/packages/rol/src/elementwise/ROL_Elementwise_Reduce.hpp +++ b/packages/rol/src/elementwise/ROL_Elementwise_Reduce.hpp @@ -42,6 +42,10 @@ // ************************************************************************ // @HEADER +#ifndef ROL_VECTOR_H +#include "ROL_Vector.hpp" +#else + #ifndef ROL_ELEMENTWISE_REDUCE_H #define ROL_ELEMENTWISE_REDUCE_H @@ -190,3 +194,4 @@ class EuclideanNormSquared : public ReductionOp { } // namespace ROL #endif +#endif diff --git a/packages/rol/src/function/ROL_ConstraintAssembler.hpp b/packages/rol/src/function/ROL_ConstraintAssembler.hpp index 6d13791df9aa..0165ee0e3792 100644 --- a/packages/rol/src/function/ROL_ConstraintAssembler.hpp +++ b/packages/rol/src/function/ROL_ConstraintAssembler.hpp @@ -59,10 +59,10 @@ namespace ROL { template struct ConstraintData { - const Ptr> constraint; - const Ptr> multiplier; - const Ptr> residual; - const Ptr> bounds; + Ptr> constraint; + Ptr> multiplier; + Ptr> residual; + Ptr> bounds; ConstraintData(const Ptr> &con, const Ptr> &mul, diff --git a/packages/rol/src/function/ROL_UpdateType.hpp b/packages/rol/src/function/ROL_UpdateType.hpp index 8cedf2659681..308ecf6d7a3a 100644 --- a/packages/rol/src/function/ROL_UpdateType.hpp +++ b/packages/rol/src/function/ROL_UpdateType.hpp @@ -45,6 +45,7 @@ #define ROL_UPDATE_TYPE_HPP #include +#include namespace ROL { diff --git a/packages/rol/src/function/ROL_VectorController.hpp b/packages/rol/src/function/ROL_VectorController.hpp index ee191a41d035..fa05977aee26 100644 --- a/packages/rol/src/function/ROL_VectorController.hpp +++ b/packages/rol/src/function/ROL_VectorController.hpp @@ -47,6 +47,8 @@ #include "ROL_Vector.hpp" #include "ROL_UpdateType.hpp" +#include +#include namespace ROL { diff --git a/packages/rol/src/function/boundconstraint/ROL_BoundConstraint_Partitioned.hpp b/packages/rol/src/function/boundconstraint/ROL_BoundConstraint_Partitioned.hpp index 5e1aa06ba0cf..20666576bdde 100644 --- a/packages/rol/src/function/boundconstraint/ROL_BoundConstraint_Partitioned.hpp +++ b/packages/rol/src/function/boundconstraint/ROL_BoundConstraint_Partitioned.hpp @@ -141,12 +141,6 @@ class BoundConstraint_Partitioned : public BoundConstraint { } void update( const Vector &x, bool flag = true, int iter = -1 ) { - const PV &xpv = dynamic_cast(x); - for( uint k=0; kisActivated() ) { - bnd_[k]->update(*(xpv.get(k)),flag,iter); - } - } } void project( Vector &x ) { diff --git a/packages/rol/src/function/objective/ROL_QuadraticObjective.hpp b/packages/rol/src/function/objective/ROL_QuadraticObjective.hpp index 0c924d3562d0..382c7d3e1e35 100644 --- a/packages/rol/src/function/objective/ROL_QuadraticObjective.hpp +++ b/packages/rol/src/function/objective/ROL_QuadraticObjective.hpp @@ -47,6 +47,7 @@ #include "ROL_Objective.hpp" #include "ROL_Vector.hpp" #include "ROL_Ptr.hpp" +#include "ROL_LinearOperator.hpp" /** @ingroup func_group \class ROL::QuadraticObjective diff --git a/packages/rol/src/step/secant/ROL_BarzilaiBorwein.hpp b/packages/rol/src/step/secant/ROL_BarzilaiBorwein.hpp index 28330bb51f56..5759070a1971 100644 --- a/packages/rol/src/step/secant/ROL_BarzilaiBorwein.hpp +++ b/packages/rol/src/step/secant/ROL_BarzilaiBorwein.hpp @@ -41,6 +41,11 @@ // ************************************************************************ // @HEADER + +#ifndef ROL_SECANTFACTORY_H +#include "ROL_SecantFactory.hpp" +#else + #ifndef ROL_BARZILAIBORWEIN_H #define ROL_BARZILAIBORWEIN_H @@ -101,3 +106,4 @@ class BarzilaiBorwein : public Secant { } #endif +#endif diff --git a/packages/rol/src/step/trustregion/ROL_CauchyPoint.hpp b/packages/rol/src/step/trustregion/ROL_CauchyPoint.hpp index 41e70b08cc35..d7939c2a76a7 100644 --- a/packages/rol/src/step/trustregion/ROL_CauchyPoint.hpp +++ b/packages/rol/src/step/trustregion/ROL_CauchyPoint.hpp @@ -41,6 +41,10 @@ // ************************************************************************ // @HEADER +#ifndef ROL_TRUSTREGIONFACTORY_H +#include "ROL_TrustRegionFactory.hpp" +#else + #ifndef ROL_CAUCHYPOINT_H #define ROL_CAUCHYPOINT_H @@ -277,3 +281,4 @@ class CauchyPoint : public TrustRegion { } #endif +#endif diff --git a/packages/rol/src/step/trustregion/ROL_DogLeg.hpp b/packages/rol/src/step/trustregion/ROL_DogLeg.hpp index 792bc65d241a..86ad2c8c6c6a 100644 --- a/packages/rol/src/step/trustregion/ROL_DogLeg.hpp +++ b/packages/rol/src/step/trustregion/ROL_DogLeg.hpp @@ -48,7 +48,7 @@ \brief Provides interface for dog leg trust-region subproblem solver. */ -#include "ROL_TrustRegion.hpp" +#include "ROL_CauchyPoint.hpp" #include "ROL_Types.hpp" namespace ROL { diff --git a/packages/rol/src/step/trustregion/ROL_TrustRegionTypes.hpp b/packages/rol/src/step/trustregion/ROL_TrustRegionTypes.hpp index b2355eaae556..3cb8ddf4c737 100644 --- a/packages/rol/src/step/trustregion/ROL_TrustRegionTypes.hpp +++ b/packages/rol/src/step/trustregion/ROL_TrustRegionTypes.hpp @@ -49,6 +49,8 @@ #ifndef ROL_TRUSTREGIONTYPES_HPP #define ROL_TRUSTREGIONTYPES_HPP +#include "ROL_Types.hpp" + namespace ROL { /** \enum ROL::ETrustRegion diff --git a/packages/rol/src/vector/ROL_Vector.hpp b/packages/rol/src/vector/ROL_Vector.hpp index 9b279039a6b0..c586aa9e0ceb 100644 --- a/packages/rol/src/vector/ROL_Vector.hpp +++ b/packages/rol/src/vector/ROL_Vector.hpp @@ -242,14 +242,14 @@ class Vector virtual void applyUnary( const Elementwise::UnaryFunction &f ) { ROL_UNUSED(f); ROL_TEST_FOR_EXCEPTION( true, std::logic_error, - "The method applyUnary wass called, but not implemented" << std::endl); + "The method applyUnary was called, but not implemented" << std::endl); } virtual void applyBinary( const Elementwise::BinaryFunction &f, const Vector &x ) { ROL_UNUSED(f); ROL_UNUSED(x); ROL_TEST_FOR_EXCEPTION( true, std::logic_error, - "The method applyBinary wass called, but not implemented" << std::endl); + "The method applyBinary was called, but not implemented" << std::endl); } virtual Real reduce( const Elementwise::ReductionOp &r ) const { diff --git a/packages/rol/src/zoo/ROL_ScalarTraits.hpp b/packages/rol/src/zoo/ROL_ScalarTraits.hpp index 9248f6a90697..affc3d4d412c 100644 --- a/packages/rol/src/zoo/ROL_ScalarTraits.hpp +++ b/packages/rol/src/zoo/ROL_ScalarTraits.hpp @@ -46,6 +46,7 @@ #define ROL_SCALARTRAITS_HPP #include +#include namespace ROL {