]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove DEAL_II_WITH_CXX11 4335/head
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Sun, 30 Apr 2017 15:49:59 +0000 (17:49 +0200)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Sun, 30 Apr 2017 19:47:57 +0000 (21:47 +0200)
30 files changed:
include/deal.II/lac/block_indices.h
include/deal.II/lac/block_linear_operator.h
include/deal.II/lac/block_vector.h
include/deal.II/lac/block_vector_base.h
include/deal.II/lac/constrained_linear_operator.h
include/deal.II/lac/iterative_inverse.h
include/deal.II/lac/linear_operator.h
include/deal.II/lac/packaged_operation.h
include/deal.II/lac/precondition.h
include/deal.II/lac/read_write_vector.h
include/deal.II/lac/read_write_vector.templates.h
include/deal.II/lac/schur_complement.h
include/deal.II/lac/sparse_matrix.h
include/deal.II/lac/sparse_matrix.templates.h
include/deal.II/lac/trilinos_block_sparse_matrix.h
include/deal.II/lac/trilinos_linear_operator.h
include/deal.II/lac/trilinos_parallel_block_vector.h
include/deal.II/lac/trilinos_sparse_matrix.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/lac/vector.h
include/deal.II/lac/vector.templates.h
source/lac/trilinos_block_vector.cc
source/lac/trilinos_sparse_matrix.cc
source/lac/trilinos_vector.cc
tests/base/cell_data_storage_01.cc
tests/base/cell_data_storage_02.cc
tests/base/quadrature_point_data_02.cc
tests/base/quadrature_point_data_03.cc
tests/base/tensor_accessors_02.cc
tests/base/unique_ptr_01.cc

index c10f1cb611b906224b1ae0da9b6b45f7a6eb78ba..1e0287698e65a06bd9d3a20bce6449883c037b55 100644 (file)
@@ -74,13 +74,9 @@ public:
    */
   BlockIndices (const std::vector<size_type> &block_sizes);
 
-#ifdef DEAL_II_WITH_CXX11
   /**
    * Move constructor. Initialize a new object by stealing the internal data of
    * another BlockIndices object.
-   *
-   * @note This constructor is only available if deal.II is configured with
-   * C++11 support.
    */
   BlockIndices (BlockIndices &&b);
 
@@ -88,7 +84,6 @@ public:
    * Copy constructor.
    */
   BlockIndices (const BlockIndices &) = default;
-#endif
 
   /**
    * Specialized constructor for a structure with blocks of equal size.
@@ -181,13 +176,11 @@ public:
    */
   BlockIndices &operator = (const BlockIndices &b);
 
-#ifdef DEAL_II_WITH_CXX11
   /**
    * Move assignment operator. Move another BlockIndices object onto the
    * current one by transferring its contents.
    */
   BlockIndices &operator = (BlockIndices &&);
-#endif
 
   /**
    * Compare whether two objects are the same, i.e. whether the number of
@@ -310,8 +303,6 @@ BlockIndices::BlockIndices (const std::vector<size_type> &block_sizes)
 
 
 
-#ifdef DEAL_II_WITH_CXX11
-
 inline
 BlockIndices::BlockIndices (BlockIndices &&b)
   :
@@ -322,8 +313,6 @@ BlockIndices::BlockIndices (BlockIndices &&b)
   b.start_indices = std::vector<size_type>(1, 0);
 }
 
-#endif
-
 
 
 inline
@@ -432,7 +421,6 @@ BlockIndices::operator = (const BlockIndices &b)
 
 
 
-#ifdef DEAL_II_WITH_CXX11
 inline
 BlockIndices &
 BlockIndices::operator = (BlockIndices &&b)
@@ -445,7 +433,6 @@ BlockIndices::operator = (BlockIndices &&b)
 
   return *this;
 }
-#endif
 
 
 
index 176afd707c31bbe811a8a386ffebe4338130178e..e62a3a42171d4b3cd4e6cb7dbbda017da75fe559 100644 (file)
@@ -21,7 +21,6 @@
 
 #include <deal.II/lac/linear_operator.h>
 
-#ifdef DEAL_II_WITH_CXX11
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -134,10 +133,6 @@ block_back_substitution(const BlockLinearOperator<Range, Domain, BlockPayload> &
  * sizes, and small block structure (as a rule of thumb, matrix blocks greater
  * than $1000\times1000$).
  *
- * @note This class is only available if deal.II was configured with C++11
- * support, i.e., if <code>DEAL_II_WITH_CXX11</code> is enabled during cmake
- * configure.
- *
  * @author Matthias Maier, 2015
  *
  * @ingroup LAOperators
@@ -901,5 +896,4 @@ block_back_substitution(const BlockLinearOperator<Range, Domain, BlockPayload> &
 
 DEAL_II_NAMESPACE_CLOSE
 
-#endif // DEAL_II_WITH_CXX11
 #endif
index f8ce49936ecc71c3d9a43f31d113804e26734633..84882804def1ba750f12363c2857fe6945aa41b6 100644 (file)
@@ -105,16 +105,11 @@ public:
   BlockVector (const BlockVector<Number> &V);
 
 
-#ifdef DEAL_II_WITH_CXX11
   /**
    * Move constructor. Creates a new vector by stealing the internal data of
    * the given argument vector.
-   *
-   * @note This constructor is only available if deal.II is configured with
-   * C++11 support.
    */
   BlockVector (BlockVector<Number> &&/*v*/) = default;
-#endif
 
 
 #ifndef DEAL_II_EXPLICIT_CONSTRUCTOR_BUG
@@ -201,16 +196,11 @@ public:
   BlockVector<Number> &
   operator= (const BlockVector<Number> &v);
 
-#ifdef DEAL_II_WITH_CXX11
   /**
    * Move the given vector. This operator replaces the present vector with
    * the contents of the given argument vector.
-   *
-   * @note This operator is only available if deal.II is configured with C++11
-   * support.
    */
   BlockVector<Number> &operator= (BlockVector<Number> &&/*v*/) = default;
-#endif
 
   /**
    * Copy operator for template arguments of different types. Resize the
index 6902ce35afb94c6602e7535c6632bec6ac136939..733cf58eeb9296024f8ced1f3937b3e2fc64400c 100644 (file)
@@ -267,11 +267,8 @@ namespace internal
        * Copy constructor from an iterator of different constness.
        *
        * @note Constructing a non-const iterator from a const iterator does
-       * not make sense. If deal.II was configured with C++11 support, then
-       * attempting this will result in a compile-time error (via
-       * <code>static_assert</code>). If deal.II was not configured with C++11
-       * support, then attempting this will result in a thrown exception in
-       * debug mode.
+       * not make sense. Attempting this will result in a compile-time error
+       * (via <code>static_assert</code>).
        */
       Iterator (const Iterator<BlockVectorType,!Constness> &c);
 
@@ -423,16 +420,6 @@ namespace internal
                         "different block vectors. There is no reasonable way "
                         "to do this.");
 
-      /**
-       * Exception thrown when one attempts to copy construct a non-const
-       * iterator from a const iterator.
-       *
-       * @note when deal.II is compiled with C++11 support this check is
-       * instead performed at compile time via <code>static_assert</code>.
-       */
-      DeclExceptionMsg (ExcCastingAwayConstness,
-                        "Constructing a non-const iterator from a const "
-                        "iterator does not make sense.");
       //@}
     private:
       /**
@@ -580,7 +567,6 @@ public:
    */
   BlockVectorBase ();
 
-#ifdef DEAL_II_WITH_CXX11
   /**
    * Copy constructor.
    */
@@ -590,12 +576,8 @@ public:
    * Move constructor. Each block of the argument vector is moved into the current
    * object if the underlying <code>VectorType</code> is move-constructible,
    * otherwise they are copied.
-   *
-   * @note This constructor is only available if deal.II is configured with
-   * C++11 support.
    */
   BlockVectorBase (BlockVectorBase &&/*V*/) = default;
-#endif
 
   /**
    * Update internal structures after resizing vectors. Whenever you reinited
@@ -743,14 +725,12 @@ public:
   BlockVectorBase &
   operator= (const BlockVectorBase &V);
 
-#ifdef DEAL_II_WITH_CXX11
   /**
    * Move assignment operator. Move each block of the given argument
    * vector into the current object if `VectorType` is
    * move-constructible, otherwise copy them.
    */
   BlockVectorBase &operator= (BlockVectorBase &&/*V*/) = default;
-#endif
 
   /**
    * Copy operator for template arguments of different types.
@@ -1046,13 +1026,9 @@ namespace internal
       // iterators, and not vice versa (i.e., Constness must always be
       // true). As mentioned above, try to check this at compile time if C++11
       // support is available.
-#ifdef DEAL_II_WITH_CXX11
       static_assert(Constness == true,
                     "Constructing a non-const iterator from a const iterator "
                     "does not make sense.");
-#else
-      Assert(Constness == true, ExcCastingAwayConstness());
-#endif
     }
 
 
index 729a65e9fcce7fe39654b969754c67f23eb51f3c..a73df3e7508f761ea4fc48b6dd5b1fcf58d182b7 100644 (file)
@@ -20,7 +20,6 @@
 #include <deal.II/lac/packaged_operation.h>
 #include <deal.II/lac/constraint_matrix.h>
 
-#ifdef DEAL_II_WITH_CXX11
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -317,5 +316,4 @@ constrained_right_hand_side(const ConstraintMatrix &constraint_matrix,
 
 DEAL_II_NAMESPACE_CLOSE
 
-#endif // DEAL_II_WITH_CXX11
 #endif
index 190936dc43787058457a7ee48016c7187147dec9..9c3dcd92316237306031215ac680793eb0db3005 100644 (file)
@@ -66,10 +66,8 @@ DEAL_II_NAMESPACE_OPEN
  * from machine accuracy, even if the errors of the outer loop are in the
  * range of machine accuracy.
  *
- * @deprecated If deal.II was configured with C++11 support, use the
- * LinearOperator class instead, see the module on
- * @ref LAOperators "linear operators"
- * for further details.
+ * @deprecated Use the LinearOperator class instead. See the module on
+ * @ref LAOperators "linear operators" for further details.
  *
  * @ingroup Matrix2
  * @author Guido Kanschat
index 59a39340f2e57dd4629008975aaed70bdbdfbe42..108d1f32b48ac6440e50bfaa6edf4c18eacff37b 100644 (file)
@@ -20,8 +20,6 @@
 #include <deal.II/base/exceptions.h>
 #include <deal.II/lac/vector_memory.h>
 
-#ifdef DEAL_II_WITH_CXX11
-
 #include <array>
 #include <functional>
 #include <type_traits>
@@ -144,10 +142,6 @@ null_operator(const LinearOperator<Range, Domain, Payload> &);
  * for linear operators have been provided within the respective
  * TrilinosWrappers (and, in the future, PetscWrappers) namespaces.
  *
- * @note This class is only available if deal.II was configured with C++11
- * support, i.e., if <code>DEAL_II_WITH_CXX11</code> is enabled during cmake
- * configure.
- *
  * @author Luca Heltai, Matthias Maier, 2015; Jean-Paul Pelteret, 2016
  *
  * @ingroup LAOperators
@@ -1302,5 +1296,4 @@ linear_operator(const OperatorExemplar &operator_exemplar, const Matrix &matrix)
 
 DEAL_II_NAMESPACE_CLOSE
 
-#endif // DEAL_II_WITH_CXX11
 #endif
index 5db537acb0a5ce54a96059371ac8c58d1dfa133a..d8029976b7104d28d4c6b1c81689a8917e603587 100644 (file)
@@ -20,8 +20,6 @@
 #include <deal.II/base/exceptions.h>
 #include <deal.II/lac/vector_memory.h>
 
-#ifdef DEAL_II_WITH_CXX11
-
 #include <functional>
 
 DEAL_II_NAMESPACE_OPEN
@@ -831,5 +829,4 @@ operator*(const PackagedOperation<Range> &comp,
 
 DEAL_II_NAMESPACE_CLOSE
 
-#endif // DEAL_II_WITH_CXX11
 #endif
index 3d92b78eff95ad19ea901e8af7834e1e0a6bf986..723078a450901128fd0622bfb95a0eecf56f7c5a 100644 (file)
@@ -1254,11 +1254,9 @@ template<class VectorType>
 inline void
 PreconditionRichardson::vmult (VectorType &dst, const VectorType &src) const
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<size_type, typename VectorType::size_type>::value,
     "PreconditionRichardson and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 
   dst.equ(relaxation,src);
 }
@@ -1269,11 +1267,9 @@ template<class VectorType>
 inline void
 PreconditionRichardson::Tvmult (VectorType &dst, const VectorType &src) const
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<size_type, typename VectorType::size_type>::value,
     "PreconditionRichardson and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 
   dst.equ(relaxation,src);
 }
@@ -1282,11 +1278,9 @@ template<class VectorType>
 inline void
 PreconditionRichardson::vmult_add (VectorType &dst, const VectorType &src) const
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<size_type, typename VectorType::size_type>::value,
     "PreconditionRichardson and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 
   dst.add(relaxation,src);
 }
@@ -1297,11 +1291,9 @@ template<class VectorType>
 inline void
 PreconditionRichardson::Tvmult_add (VectorType &dst, const VectorType &src) const
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<size_type, typename VectorType::size_type>::value,
     "PreconditionRichardson and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 
   dst.add(relaxation,src);
 }
@@ -1362,11 +1354,9 @@ template<class VectorType>
 inline void
 PreconditionJacobi<MatrixType>::vmult (VectorType &dst, const VectorType &src) const
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<typename PreconditionJacobi<MatrixType>::size_type, typename VectorType::size_type>::value,
     "PreconditionJacobi and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 
   Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->precondition_Jacobi (dst, src, this->relaxation);
@@ -1379,11 +1369,9 @@ template<class VectorType>
 inline void
 PreconditionJacobi<MatrixType>::Tvmult (VectorType &dst, const VectorType &src) const
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<typename PreconditionJacobi<MatrixType>::size_type, typename VectorType::size_type>::value,
     "PreconditionJacobi and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 
   Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->precondition_Jacobi (dst, src, this->relaxation);
@@ -1396,11 +1384,9 @@ template<class VectorType>
 inline void
 PreconditionJacobi<MatrixType>::step (VectorType &dst, const VectorType &src) const
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<typename PreconditionJacobi<MatrixType>::size_type, typename VectorType::size_type>::value,
     "PreconditionJacobi and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 
   Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->Jacobi_step (dst, src, this->relaxation);
@@ -1413,11 +1399,9 @@ template<class VectorType>
 inline void
 PreconditionJacobi<MatrixType>::Tstep (VectorType &dst, const VectorType &src) const
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<typename PreconditionJacobi<MatrixType>::size_type, typename VectorType::size_type>::value,
     "PreconditionJacobi and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 
   step (dst, src);
 }
@@ -1431,11 +1415,9 @@ template<class VectorType>
 inline void
 PreconditionSOR<MatrixType>::vmult (VectorType &dst, const VectorType &src) const
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<typename PreconditionSOR<MatrixType>::size_type, typename VectorType::size_type>::value,
     "PreconditionSOR and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 
   Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->precondition_SOR (dst, src, this->relaxation);
@@ -1448,11 +1430,9 @@ template<class VectorType>
 inline void
 PreconditionSOR<MatrixType>::Tvmult (VectorType &dst, const VectorType &src) const
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<typename PreconditionSOR<MatrixType>::size_type, typename VectorType::size_type>::value,
     "PreconditionSOR and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 
   Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->precondition_TSOR (dst, src, this->relaxation);
@@ -1465,11 +1445,9 @@ template<class VectorType>
 inline void
 PreconditionSOR<MatrixType>::step (VectorType &dst, const VectorType &src) const
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<typename PreconditionSOR<MatrixType>::size_type, typename VectorType::size_type>::value,
     "PreconditionSOR and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 
   Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->SOR_step (dst, src, this->relaxation);
@@ -1482,11 +1460,9 @@ template<class VectorType>
 inline void
 PreconditionSOR<MatrixType>::Tstep (VectorType &dst, const VectorType &src) const
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<typename PreconditionSOR<MatrixType>::size_type, typename VectorType::size_type>::value,
     "PreconditionSOR and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 
   Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->TSOR_step (dst, src, this->relaxation);
@@ -1535,11 +1511,9 @@ template<class VectorType>
 inline void
 PreconditionSSOR<MatrixType>::vmult (VectorType &dst, const VectorType &src) const
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<typename PreconditionSSOR<MatrixType>::size_type, typename VectorType::size_type>::value,
     "PreconditionSSOR and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 
   Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->precondition_SSOR (dst, src, this->relaxation, pos_right_of_diagonal);
@@ -1552,11 +1526,9 @@ template<class VectorType>
 inline void
 PreconditionSSOR<MatrixType>::Tvmult (VectorType &dst, const VectorType &src) const
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<typename PreconditionSSOR<MatrixType>::size_type, typename VectorType::size_type>::value,
     "PreconditionSSOR and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 
   Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->precondition_SSOR (dst, src, this->relaxation, pos_right_of_diagonal);
@@ -1569,11 +1541,9 @@ template<class VectorType>
 inline void
 PreconditionSSOR<MatrixType>::step (VectorType &dst, const VectorType &src) const
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<typename PreconditionSSOR<MatrixType>::size_type, typename VectorType::size_type>::value,
     "PreconditionSSOR and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 
   Assert (this->A!=nullptr, ExcNotInitialized());
   this->A->SSOR_step (dst, src, this->relaxation);
@@ -1586,11 +1556,9 @@ template<class VectorType>
 inline void
 PreconditionSSOR<MatrixType>::Tstep (VectorType &dst, const VectorType &src) const
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<typename PreconditionSSOR<MatrixType>::size_type, typename VectorType::size_type>::value,
     "PreconditionSSOR and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 
   step (dst, src);
 }
@@ -1630,11 +1598,9 @@ template <typename VectorType>
 inline void
 PreconditionPSOR<MatrixType>::vmult (VectorType &dst, const VectorType &src) const
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<typename PreconditionPSOR<MatrixType>::size_type, typename VectorType::size_type>::value,
     "PreconditionPSOR and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 
   Assert (this->A!=nullptr, ExcNotInitialized());
   dst = src;
@@ -1648,11 +1614,9 @@ template<class VectorType>
 inline void
 PreconditionPSOR<MatrixType>::Tvmult (VectorType &dst, const VectorType &src) const
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<typename PreconditionPSOR<MatrixType>::size_type, typename VectorType::size_type>::value,
     "PreconditionPSOR and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 
   Assert (this->A!=nullptr, ExcNotInitialized());
   dst = src;
@@ -2016,11 +1980,9 @@ PreconditionChebyshev<MatrixType,VectorType,PreconditionerType>::PreconditionChe
   delta          (1.),
   is_initialized (false)
 {
-#ifdef DEAL_II_WITH_CXX11
   static_assert(
     std::is_same<size_type, typename VectorType::size_type>::value,
     "PreconditionChebyshev and VectorType must have the same size_type.");
-#endif // DEAL_II_WITH_CXX11
 }
 
 
index 631125cfb756e237083e4f08c267b077ac87daba..9cb64ea562f2fc532dcda158108955eee2d4b509 100644 (file)
@@ -202,7 +202,6 @@ namespace LinearAlgebra
     virtual void reinit (const IndexSet &locally_stored_indices,
                          const bool      omit_zeroing_entries = false);
 
-#ifdef DEAL_II_WITH_CXX11
     /**
      * Apply the functor @p func to each element of the vector. The functor
      * should look like
@@ -218,7 +217,6 @@ namespace LinearAlgebra
      */
     template <typename Functor>
     void apply(const Functor &func);
-#endif
 
     /**
      * Swap the contents of this vector and the other vector @p v. One could
@@ -571,7 +569,6 @@ namespace LinearAlgebra
      */
     template <typename Number2> friend class ReadWriteVector;
 
-#ifdef DEAL_II_WITH_CXX11
   private:
     /**
      * This class provides a wrapper around a Functor which acts on
@@ -605,7 +602,6 @@ namespace LinearAlgebra
        */
       const Functor &functor;
     };
-#endif
   };
 
   /*@}*/
@@ -881,7 +877,6 @@ namespace LinearAlgebra
 
 
 
-#ifdef DEAL_II_WITH_CXX11
   template <typename Number>
   template <typename Functor>
   inline
@@ -904,7 +899,6 @@ namespace LinearAlgebra
     for (size_type i=begin; i<end; ++i)
       functor(parent.val[i]);
   }
-#endif
 
 #endif  // ifndef DOXYGEN
 
index fd25e4b344125015be2d91eb6a6ca0cbefaace83..7371ad215eaf5b91dfa917b29f0d1440f5945da9 100644 (file)
@@ -133,7 +133,6 @@ namespace LinearAlgebra
 
 
 
-#ifdef DEAL_II_WITH_CXX11
   template <typename Number>
   template <typename Functor>
   void
@@ -142,7 +141,6 @@ namespace LinearAlgebra
     FunctorTemplate<Functor> functor(*this, func);
     internal::VectorOperations::parallel_for(functor, 0, n_elements(), thread_loop_partitioner);
   }
-#endif
 
 
 
index 0ef8e1cc8660b595c06f7e924e49eb57978b03b7..2679af53821fedcc31dc1a46528b2a7493a17970 100644 (file)
@@ -22,7 +22,6 @@
 #include <deal.II/lac/linear_operator.h>
 #include <deal.II/lac/packaged_operation.h>
 
-#ifdef DEAL_II_WITH_CXX11
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -330,5 +329,4 @@ postprocess_schur_solution (const LinearOperator<Range_1, Domain_1, Payload> &A_
 
 DEAL_II_NAMESPACE_CLOSE
 
-#endif // DEAL_II_WITH_CXX11
 #endif
index ca128cafaeebc19e1e237808f42dbb42957704ce..c73d56a39e8aefb70b2561332510bd509f0a9914 100644 (file)
@@ -537,19 +537,14 @@ public:
    */
   SparseMatrix (const SparseMatrix &);
 
-#ifdef DEAL_II_WITH_CXX11
   /**
    * Move constructor. Construct a new sparse matrix by transferring the
    * internal data of the matrix @p m into a new object.
    *
    * Move construction allows an object to be returned from a function or
    * packed into a tuple even when the class cannot be copy-constructed.
-   *
-   * @note this constructor is only available if deal.II is configured with
-   * C++11 support.
    */
   SparseMatrix (SparseMatrix<number> &&m);
-#endif
 
   /**
    * Constructor. Takes the given matrix sparsity structure to represent the
@@ -596,9 +591,6 @@ public:
   /**
    * Move assignment operator. This operator replaces the present matrix with
    * @p m by transferring the internal data of @p m.
-   *
-   * @note This operator is only available if deal.II is configured with C++11
-   * support.
    */
   SparseMatrix<number> &operator = (SparseMatrix<number> &&m);
 #endif
index 316c5f75b2d76e776fe47cacfcd1d8de50420676..bd1d517d9f89785eed7f4a3c7d401c397b8fb88e 100644 (file)
@@ -71,7 +71,6 @@ SparseMatrix<number>::SparseMatrix (const SparseMatrix &m)
 
 
 
-#ifdef DEAL_II_WITH_CXX11
 template <typename number>
 SparseMatrix<number>::SparseMatrix (SparseMatrix<number> &&m)
   :
@@ -84,7 +83,6 @@ SparseMatrix<number>::SparseMatrix (SparseMatrix<number> &&m)
   m.val = nullptr;
   m.max_len = 0;
 }
-#endif
 
 
 
@@ -104,7 +102,6 @@ SparseMatrix<number>::operator = (const SparseMatrix<number> &m)
 
 
 
-#ifdef DEAL_II_WITH_CXX11
 template <typename number>
 SparseMatrix<number> &
 SparseMatrix<number>::operator = (SparseMatrix<number> &&m)
@@ -119,7 +116,6 @@ SparseMatrix<number>::operator = (SparseMatrix<number> &&m)
 
   return *this;
 }
-#endif
 
 
 
index 4864876808410fe4852bcf3a68922aec53fe44d0..9753e38bb2c90da23180b73a6c5674f31f94b0be 100644 (file)
@@ -564,8 +564,6 @@ namespace TrilinosWrappers
   }
 
 
-#ifdef DEAL_II_WITH_CXX11
-
 
   namespace internal
   {
@@ -616,7 +614,6 @@ namespace TrilinosWrappers
     } /*namespace BlockLinearOperator*/
   } /* namespace internal */
 
-#endif // DEAL_II_WITH_CXX11
 
 }/* namespace TrilinosWrappers */
 
index c5cb9eecc80ba76ab2359c5222243df68c120279..d2b8d8fd87c22944aaed499c53cdf70475233ed9 100644 (file)
@@ -18,7 +18,7 @@
 
 #include <deal.II/base/config.h>
 
-#if defined(DEAL_II_WITH_CXX11) && defined(DEAL_II_WITH_TRILINOS)
+#if defined(DEAL_II_WITH_TRILINOS)
 
 #include <deal.II/lac/linear_operator.h>
 #include <deal.II/lac/block_linear_operator.h>
@@ -222,5 +222,5 @@ namespace TrilinosWrappers
 
 DEAL_II_NAMESPACE_CLOSE
 
-#endif // DEAL_II_WITH_CXX11 && DEAL_II_WITH_TRILINOS
+#endif // DEAL_II_WITH_TRILINOS
 #endif
index 9d5d3f3798ab8963f91f6e297d12452f410672ed..bf515470739c64e2f2675fd305174b6c41790b88 100644 (file)
@@ -132,16 +132,11 @@ namespace TrilinosWrappers
        */
       BlockVector (const BlockVector  &v);
 
-#ifdef DEAL_II_WITH_CXX11
       /**
        * Move constructor. Creates a new vector by stealing the internal data
        * of the vector @p v.
-       *
-       * @note This constructor is only available if deal.II is configured
-       * with C++11 support.
        */
       BlockVector (BlockVector &&v);
-#endif
 
       /**
        * Creates a block vector consisting of <tt>num_blocks</tt> components,
@@ -166,16 +161,11 @@ namespace TrilinosWrappers
        */
       BlockVector &operator= (const BlockVector &v);
 
-#ifdef DEAL_II_WITH_CXX11
       /**
        * Move the given vector. This operator replaces the present vector with
        * @p v by efficiently swapping the internal data structures.
-       *
-       * @note This operator is only available if deal.II is configured with
-       * C++11 support.
        */
       BlockVector &operator= (BlockVector &&v);
-#endif
 
       /**
        * Copy operator for arguments of the localized Trilinos vector type.
@@ -400,7 +390,6 @@ namespace TrilinosWrappers
 
 
 
-#ifdef DEAL_II_WITH_CXX11
     inline
     BlockVector::BlockVector (BlockVector &&v)
     {
@@ -408,7 +397,6 @@ namespace TrilinosWrappers
       reinit (0);
       swap(v);
     }
-#endif
 
 
 
index 36cb54b780829ca3d8a5f90021c6b2745d15391b..fb79c1ebd756a68d5794ae017451b0a290642f8b 100644 (file)
 #  include <deal.II/lac/trilinos_vector.h>
 #  include <deal.II/lac/trilinos_epetra_vector.h>
 #  include <deal.II/lac/vector_view.h>
+#  include <deal.II/lac/vector_memory.h>
 
-#ifdef DEAL_II_WITH_CXX11
-#include <deal.II/lac/vector_memory.h>
-#include <type_traits>
-#endif // DEAL_II_WITH_CXX11
-
+#  include <type_traits>
 #  include <vector>
 #  include <cmath>
 #  include <memory>
@@ -2047,7 +2044,6 @@ namespace TrilinosWrappers
   };
 
 
-#ifdef DEAL_II_WITH_CXX11
 
   // forwards declarations
   class SolverBase;
@@ -2523,7 +2519,6 @@ namespace TrilinosWrappers
     } /* namespace LinearOperator */
   } /* namespace internal */
 
-#endif // DEAL_II_WITH_CXX11
 
 
 // -------------------------- inline and template functions ----------------------
@@ -3173,7 +3168,6 @@ namespace TrilinosWrappers
   }
 
 
-#ifdef DEAL_II_WITH_CXX11
   namespace internal
   {
     namespace LinearOperator
@@ -3262,7 +3256,6 @@ namespace TrilinosWrappers
       }
     } // namespace LinearOperator
   } // namespace internal
-#endif // DEAL_II_WITH_CXX11
 
 #endif // DOXYGEN
 
index fa99de015a256e16c7f842a5b733076d0278e3fb..28f746750d98caed66ff3012bd755f1a7af214eb 100644 (file)
@@ -291,16 +291,11 @@ namespace TrilinosWrappers
        */
       Vector (const Vector &v);
 
-#ifdef DEAL_II_WITH_CXX11
       /**
        * Move constructor. Creates a new vector by stealing the internal data
        * of the vector @p v.
-       *
-       * @note This constructor is only available if deal.II is configured
-       * with C++11 support.
        */
       Vector (Vector &&v);
-#endif
 
       /**
        * Destructor.
@@ -355,16 +350,11 @@ namespace TrilinosWrappers
        */
       Vector &operator= (const Vector &v);
 
-#ifdef DEAL_II_WITH_CXX11
       /**
        * Move the given vector. This operator replaces the present vector with
        * @p v by efficiently swapping the internal data structures.
-       *
-       * @note This operator is only available if deal.II is configured with
-       * C++11 support.
        */
       Vector &operator= (Vector &&v);
-#endif
 
       /**
        * Copy operator from a given localized vector (present on all
index 7f6431c34ebb83f3b2261a34e3e4130ff7094c56..6410f8cba128bc2baea504c14f87b846e869939b 100644 (file)
@@ -196,17 +196,11 @@ public:
    */
   Vector (const Vector<Number> &v);
 
-#ifdef DEAL_II_WITH_CXX11
   /**
    * Move constructor. Creates a new vector by stealing the internal data of
    * the vector @p v.
-   *
-   * @note This constructor is only available if deal.II is configured with
-   * C++11 support.
    */
   Vector (Vector<Number> &&v);
-#endif
-
 
 #ifndef DEAL_II_EXPLICIT_CONSTRUCTOR_BUG
   /**
@@ -383,9 +377,6 @@ public:
    * Move the given vector. This operator replaces the present vector with
    * the internal data of the vector @p v and resets @p v to the state it would
    * have after being newly default-constructed.
-   *
-   * @note This operator is only available if deal.II is configured with C++11
-   * support.
    */
   Vector<Number> &operator= (Vector<Number> &&v);
 #endif
index 674404dcbf34d4d23f78b2f004cf09ce536bb7fd..38554edc26d17d6261eb69ce3f67ed56d3873be1 100644 (file)
@@ -59,7 +59,6 @@ Vector<Number>::Vector (const Vector<Number> &v)
 
 
 
-#ifdef DEAL_II_WITH_CXX11
 template <typename Number>
 Vector<Number>::Vector (Vector<Number> &&v)
   :
@@ -73,7 +72,6 @@ Vector<Number>::Vector (Vector<Number> &&v)
   v.max_vec_size = 0;
   v.val = nullptr;
 }
-#endif
 
 
 
index 811dc943fa257ce772159db955f7230ab41e484f..8897cb05a91beecbd2cc94d63b7fe3503e420288 100644 (file)
@@ -76,14 +76,12 @@ namespace TrilinosWrappers
 
 
 
-#ifdef DEAL_II_WITH_CXX11
     BlockVector &
     BlockVector::operator= (BlockVector &&v)
     {
       swap(v);
       return *this;
     }
-#endif
 
 
 
index 9081b440bef26b3d26cc48f3613a7281b5eb18e0..69fe10bba68b41438ded400df565640b049e7d7a 100644 (file)
 #  include <deal.II/lac/dynamic_sparsity_pattern.h>
 #  include <deal.II/lac/sparsity_tools.h>
 #  include <deal.II/lac/la_parallel_vector.h>
-
-#ifdef DEAL_II_WITH_CXX11
 #  include <deal.II/lac/trilinos_precondition.h>
-#endif
 
 DEAL_II_DISABLE_EXTRA_DIAGNOSTICS
 #  include <Epetra_Export.h>
@@ -2501,7 +2498,6 @@ namespace TrilinosWrappers
   }
 }
 
-#ifdef DEAL_II_WITH_CXX11
 
 namespace TrilinosWrappers
 {
@@ -3400,7 +3396,6 @@ namespace TrilinosWrappers
   } /* namespace internal */
 } /* namespace TrilinosWrappers */
 
-#endif // DEAL_II_WITH_CXX11
 
 
 // explicit instantiations
index 9858a5d9f855a2e758efb40d3df79759ddd9f877..50e454b0faa7f8d13a1d6efc1872cf37d7fa692d 100644 (file)
@@ -127,7 +127,6 @@ namespace TrilinosWrappers
 
 
 
-#ifdef DEAL_II_WITH_CXX11
     Vector::Vector (Vector &&v)
     {
       // initialize a minimal, valid object and swap
@@ -137,7 +136,6 @@ namespace TrilinosWrappers
 
       swap(v);
     }
-#endif
 
 
 
@@ -566,13 +564,11 @@ namespace TrilinosWrappers
 
 
 
-#ifdef DEAL_II_WITH_CXX11
     Vector &Vector::operator= (Vector &&v)
     {
       swap(v);
       return *this;
     }
-#endif
 
 
 
index 683bbfec5a30d9b1efb15b5c95a8f07b5278af4e..3b97d750acd486f499ca862b039dd0b9a8548cf3 100644 (file)
@@ -20,8 +20,6 @@
 
 #include "../tests.h"
 
-#ifdef DEAL_II_WITH_CXX11
-
 #include <deal.II/base/logstream.h>
 #include <deal.II/base/tensor.h>
 #include <deal.II/grid/tria.h>
@@ -160,12 +158,3 @@ int main(int argc, char *argv[])
 
   test<2>();
 }
-
-#else
-int main(int argc, char *argv[])
-{
-  Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
-  initlog();
-  deallog << "Ok" << std::endl;
-}
-#endif
index 8c0f2a84a844a1149aa4300600c4095b945d9a0b..60b9e87a01938102b34e6635981e3565bea28cad 100644 (file)
@@ -20,8 +20,6 @@
 
 #include "../tests.h"
 
-#ifdef DEAL_II_WITH_CXX11
-
 #include <deal.II/base/logstream.h>
 #include <deal.II/base/tensor.h>
 #include <deal.II/grid/tria.h>
@@ -141,12 +139,3 @@ int main(int argc, char *argv[])
 
   test<2>();
 }
-
-#else
-int main(int argc, char *argv[])
-{
-  Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
-  initlog();
-  deallog << "Ok" << std::endl;
-}
-#endif
index 2dbb269c7a1bfc277c55f42fc343d118dd18868d..f60677db2b57b9f083bd47940b163e0a79a275a5 100644 (file)
@@ -24,7 +24,6 @@
 
 #include "../tests.h"
 
-#ifdef DEAL_II_WITH_CXX11
 #include <deal.II/base/logstream.h>
 #include <deal.II/base/tensor.h>
 #include <deal.II/grid/tria.h>
@@ -219,15 +218,3 @@ int main(int argc, char *argv[])
 
   test<2>();
 }
-
-#else
-int main(int argc, char *argv[])
-{
-  Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
-  mpi_initlog();
-
-  deallog << "Ok" << std::endl;
-}
-
-
-#endif
index 4642896d61457c28ebd2e4524b4ddbf162f66cab..24cdab3426827d109876f2ecde70483fd050bc93 100644 (file)
@@ -20,7 +20,6 @@
 
 #include "../tests.h"
 
-#ifdef DEAL_II_WITH_CXX11
 #include <deal.II/base/logstream.h>
 #include <deal.II/base/tensor.h>
 #include <deal.II/grid/tria.h>
@@ -224,15 +223,3 @@ int main(int argc, char *argv[])
 
   test<2>();
 }
-
-#else
-int main(int argc, char *argv[])
-{
-  Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
-  mpi_initlog();
-
-  deallog << "Ok" << std::endl;
-}
-
-
-#endif
index 2e7880b3b01ce5bfffc48c55ec68e49bed7459d7..c097ca1063f247c5b86321ad3331d3cf0bed2965 100644 (file)
@@ -18,9 +18,7 @@
 #include <deal.II/base/tensor_accessors.h>
 #include <deal.II/base/table_indices.h>
 
-#ifdef DEAL_II_WITH_CXX11
 #include <array>
-#endif
 
 int main()
 {
@@ -77,12 +75,8 @@ int main()
     // via std::array
 
     // via std::array:
-#ifdef DEAL_II_WITH_CXX11
     std::array<unsigned int, 5> temp {{2, 1, 0, 2, 1}};
     deallog << TensorAccessors::extract<5>(foo, temp) << std::endl;
-#else
-    deallog << 42. << std::endl;
-#endif
   }
 
 }
index af5ed55fdb3bf55ae09116cd21ab6192a36896c8..ea890453ba3859f74d554abddf41dc6dcfe81587 100644 (file)
@@ -72,7 +72,6 @@ int main ()
 
   // test with plain unique_ptr, but also copy stuff. this only works
   // with move constructors, so test only in C++11 mode
-#ifdef DEAL_II_WITH_CXX11
   {
     AssertThrow (counter == 0, ExcInternalError());
     {
@@ -84,7 +83,6 @@ int main ()
     }
     AssertThrow (counter == 0, ExcInternalError());
   }
-#endif
 
   deallog << "OK" << std::endl;
 }

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.