]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Replace all occurrences of std_cxx1x by std_cxx11.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Sun, 24 Aug 2014 16:46:25 +0000 (11:46 -0500)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Mon, 1 Sep 2014 19:49:07 +0000 (14:49 -0500)
Keep the old files and namespace for backward compatibility.

139 files changed:
doc/doxygen/headers/c++11.h
doc/doxygen/headers/multithreading.h
doc/doxygen/headers/std_cxx11.h [moved from doc/doxygen/headers/std_cxx1x.h with 98% similarity]
doc/news/changes.h
examples/step-13/step-13.cc
examples/step-14/step-14.cc
examples/step-22/step-22.cc
examples/step-31/step-31.cc
examples/step-32/step-32.cc
examples/step-34/step-34.cc
examples/step-35/step-35.cc
examples/step-42/step-42.cc
examples/step-43/step-43.cc
examples/step-51/step-51.cc
examples/step-52/step-52.cc
examples/step-53/step-53.cc
examples/step-9/step-9.cc
include/deal.II/base/aligned_vector.h
include/deal.II/base/data_out_base.h
include/deal.II/base/function.h
include/deal.II/base/function_lib.h
include/deal.II/base/graph_coloring.h
include/deal.II/base/logstream.h
include/deal.II/base/memory_consumption.h
include/deal.II/base/mg_level_object.h
include/deal.II/base/parallel.h
include/deal.II/base/parameter_handler.h
include/deal.II/base/polynomial.h
include/deal.II/base/std_cxx11/array.h [new file with mode: 0644]
include/deal.II/base/std_cxx11/bind.h [new file with mode: 0644]
include/deal.II/base/std_cxx11/condition_variable.h [new file with mode: 0644]
include/deal.II/base/std_cxx11/function.h [new file with mode: 0644]
include/deal.II/base/std_cxx11/mutex.h [new file with mode: 0644]
include/deal.II/base/std_cxx11/shared_ptr.h [new file with mode: 0644]
include/deal.II/base/std_cxx11/thread.h [new file with mode: 0644]
include/deal.II/base/std_cxx11/tuple.h [new file with mode: 0644]
include/deal.II/base/std_cxx11/type_traits.h [new file with mode: 0644]
include/deal.II/base/std_cxx1x/array.h
include/deal.II/base/std_cxx1x/bind.h
include/deal.II/base/std_cxx1x/condition_variable.h
include/deal.II/base/std_cxx1x/function.h
include/deal.II/base/std_cxx1x/mutex.h
include/deal.II/base/std_cxx1x/shared_ptr.h
include/deal.II/base/std_cxx1x/thread.h
include/deal.II/base/std_cxx1x/tuple.h
include/deal.II/base/std_cxx1x/type_traits.h
include/deal.II/base/synchronous_iterator.h
include/deal.II/base/thread_management.h
include/deal.II/base/time_stepping.h
include/deal.II/base/time_stepping.templates.h
include/deal.II/base/work_stream.h
include/deal.II/distributed/tria.h
include/deal.II/dofs/dof_handler.h
include/deal.II/fe/fe_system.h
include/deal.II/grid/tria.h
include/deal.II/grid/tria_boundary.h
include/deal.II/hp/fe_collection.h
include/deal.II/hp/fe_values.h
include/deal.II/hp/mapping_collection.h
include/deal.II/hp/q_collection.h
include/deal.II/lac/chunk_sparse_matrix.templates.h
include/deal.II/lac/filtered_matrix.h
include/deal.II/lac/iterative_inverse.h
include/deal.II/lac/lapack_full_matrix.h
include/deal.II/lac/matrix_block.h
include/deal.II/lac/parallel_vector.h
include/deal.II/lac/parallel_vector.templates.h
include/deal.II/lac/petsc_matrix_base.h
include/deal.II/lac/petsc_solver.h
include/deal.II/lac/slepc_solver.h
include/deal.II/lac/slepc_spectral_transformation.h
include/deal.II/lac/sparse_matrix.templates.h
include/deal.II/lac/trilinos_precondition.h
include/deal.II/lac/trilinos_solver.h
include/deal.II/lac/trilinos_sparse_matrix.h
include/deal.II/lac/trilinos_sparsity_pattern.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/lac/trilinos_vector_base.h
include/deal.II/lac/vector.templates.h
include/deal.II/matrix_free/dof_info.h
include/deal.II/matrix_free/dof_info.templates.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/matrix_free/mapping_info.templates.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/meshworker/dof_info.h
include/deal.II/meshworker/integration_info.h
include/deal.II/meshworker/integration_info.templates.h
include/deal.II/meshworker/local_integrator.h
include/deal.II/meshworker/local_results.h
include/deal.II/meshworker/loop.h
include/deal.II/multigrid/mg_matrix.h
include/deal.II/multigrid/mg_transfer.h
include/deal.II/multigrid/mg_transfer_block.h
include/deal.II/multigrid/mg_transfer_component.h
include/deal.II/multigrid/sparse_matrix_collection.h
include/deal.II/numerics/data_out.h
include/deal.II/numerics/data_out_dof_data.h
include/deal.II/numerics/data_out_faces.h
include/deal.II/numerics/data_out_rotation.h
include/deal.II/numerics/derivative_approximation.h
include/deal.II/numerics/vector_tools.templates.h
source/base/data_out_base.cc
source/base/data_out_base.inst.in
source/base/function.cc
source/base/function_lib.cc
source/base/parameter_handler.cc
source/base/polynomial.cc
source/distributed/solution_transfer.cc
source/distributed/tria.cc
source/dofs/dof_tools_constraints.cc
source/fe/fe_system.cc
source/fe/fe_tools.cc
source/fe/fe_tools_interpolate.cc
source/fe/fe_values.cc
source/grid/grid_out.cc
source/grid/grid_reordering.cc
source/grid/grid_tools.cc
source/grid/tria.cc
source/grid/tria_boundary.cc
source/hp/dof_handler.cc
source/hp/fe_collection.cc
source/hp/fe_values.cc
source/hp/mapping_collection.cc
source/lac/trilinos_sparse_matrix.cc
source/lac/trilinos_vector.cc
source/multigrid/mg_transfer_block.cc
source/multigrid/mg_transfer_component.cc
source/multigrid/mg_transfer_prebuilt.cc
source/numerics/data_out.cc
source/numerics/data_out_dof_data.cc
source/numerics/data_out_dof_data.inst.in
source/numerics/data_out_faces.cc
source/numerics/data_out_rotation.cc
source/numerics/derivative_approximation.cc
source/numerics/error_estimator.cc
source/numerics/error_estimator_1d.cc
source/numerics/matrix_tools.cc
source/numerics/point_value_history.cc
source/numerics/time_dependent.cc

index c543616d6f11bd31d7bfc9d92d36700a09534b45..bafba4d1af93729bc873dc1146f84a61d2393de1 100644 (file)
  * are available also for pre-C++11 compilers. This is done using
  * the following approach:
  *
- * - We create a namespace std_cxx1x.
+ * - We create a namespace std_cxx11.
  * - If the compiler supports C++11, we import the relevant classes
  *   and functions into this namespace using statements such as
  *   @code
- *     namespace std_cxx1x {  using std::shared_ptr;  }
+ *     namespace std_cxx11 {  using std::shared_ptr;  }
  *   @endcode
  * - If the compiler does not support C++11, if its support for
  *   C++11 is incomplete, or if it is buggy, then we use as a fallback
  *   <a href="http://www.boost.org">BOOST library</a> through
  *   statements such as
  *   @code
- *     namespace std_cxx1x {  using boost::shared_ptr;  }
+ *     namespace std_cxx11 {  using boost::shared_ptr;  }
  *   @endcode
  *
- * Consequently, namespace std_cxx1x contains all of the symbols
+ * Consequently, namespace std_cxx11 contains all of the symbols
  * we require. The classes that can be used this way are obviously
  * a subset of the intersection between C++11 and what BOOST provides.
  *
index fd127a27b46a60dc1ac92b595208c4f35a872f0d..79317d676b779ed30b6831f3a2ad4ec39a1057c9 100644 (file)
                               Vector       &dst) const
     {
       parallel::transform (dst.begin(), dst.end(),
-                           std_cxx1x::bind (&SparseMatrix::vmult_one_row,
+                           std_cxx11::bind (&SparseMatrix::vmult_one_row,
                                         this,
-                                        std_cxx1x::cref(src),
-                                        std_cxx1x::ref(dst),
-                                        std_cxx1x::_1),
+                                        std_cxx11::cref(src),
+                                        std_cxx11::ref(dst),
+                                        std_cxx11::_1),
                            200);
     }
  * @endcode
  * Note how we use <a
- * href="http://www.boost.org/doc/libs/1_37_0/libs/bind/bind.html">std_cxx1x::bind</a>
+ * href="http://www.boost.org/doc/libs/1_37_0/libs/bind/bind.html">std_cxx11::bind</a>
  * to <i>bind</i> certain arguments to the <code>vmult_one_row</code>
  * function, leaving one argument open and thus allowing the
  * parallel::transform function to consider the passed function argument as
  * unary. Also note that we need to make the source and destination vectors as
- * (const) references to prevent std_cxx1x::bind from passing them by value
+ * (const) references to prevent std_cxx11::bind from passing them by value
  * (implying a copy for <code>src</code> and writing the result into a
  * temporary copy of <code>dst</code>, neither of which is what we desired).
  * Finally, notice the grainsize of a minimum of 200 rows of a matrix that
                               Vector       &dst) const
     {
        parallel::apply_to_subranges (0, n_rows(),
-                                     std_cxx1x::bind (vmult_on_subrange,
+                                     std_cxx11::bind (vmult_on_subrange,
                                                   this,
-                                                  std_cxx1x::_1, std_cxx1x::_2,
-                                                  std_cxx1x::cref(src),
-                                                  std_cxx1x::ref(dst)),
+                                                  std_cxx11::_1, std_cxx11::_2,
+                                                  std_cxx11::cref(src),
+                                                  std_cxx11::ref(dst)),
                                      200);
     }
  * @endcode
       return
         std::sqrt
         (parallel::accumulate_from_subranges (0, n_rows(),
-                                              std_cxx1x::bind (mat_norm_sqr_on_subrange,
+                                              std_cxx11::bind (mat_norm_sqr_on_subrange,
                                                            this,
-                                                           std_cxx1x::_1, std_cxx1x::_2,
-                                                           std_cxx1x::cref(x)),
+                                                           std_cxx11::_1, std_cxx11::_2,
+                                                           std_cxx11::cref(x)),
                                               200));
     }
  * @endcode
      // ...is the same as:
      WorkStream::run (dof_handler.begin_active(),
                       dof_handler.end(),
-                      std_cxx1x::bind(&MyClass<dim>::assemble_on_one_cell,
+                      std_cxx11::bind(&MyClass<dim>::assemble_on_one_cell,
                                       *this,
-                                      std_cxx1x::_1,
-                                      std_cxx1x::_2,
-                                      std_cxx1x::_3),
-                      std_cxx1x::bind(&MyClass<dim>::copy_local_to_global,
+                                      std_cxx11::_1,
+                                      std_cxx11::_2,
+                                      std_cxx11::_3),
+                      std_cxx11::bind(&MyClass<dim>::copy_local_to_global,
                                       *this,
-                                      std_cxx1x::_1),
+                                      std_cxx11::_1),
                       per_task_data);
  * @endcode
- * Note how <code>std_cxx1x::bind</code> produces a function object that takes three
+ * Note how <code>std_cxx11::bind</code> produces a function object that takes three
  * arguments by binding the member function to the <code>*this</code>
- * object. <code>std_cxx1x::_1, std_cxx1x::_2</code> and <code>std_cxx1x::_3</code> are placeholders for the first,
+ * object. <code>std_cxx11::_1, std_cxx11::_2</code> and <code>std_cxx11::_3</code> are placeholders for the first,
  * second and third argument that can be specified later on. In other words, for
  * example if <code>p</code> is the result of the first call to
- * <code>std_cxx1x::bind</code>, then the call <code>p(cell, scratch_data,
+ * <code>std_cxx11::bind</code>, then the call <code>p(cell, scratch_data,
  * per_task_data)</code> will result in executing
  * <code>this-@>assemble_on_one_cell (cell, scratch_data, per_task_data)</code>,
- * i.e. <code>std_cxx1x::bind</code> has bound the object to the function pointer
+ * i.e. <code>std_cxx11::bind</code> has bound the object to the function pointer
  * but left the three arguments open for later.
  *
  * Similarly, let us assume that <code>MyClass::assemble_on_one_cell</code>
  * @code
      WorkStream::run (dof_handler.begin_active(),
                       dof_handler.end(),
-                      std_cxx1x::bind(&MyClass<dim>::assemble_on_one_cell,
+                      std_cxx11::bind(&MyClass<dim>::assemble_on_one_cell,
                                       *this,
                                       current_solution,
-                                      std_cxx1x::_1,
-                                      std_cxx1x::_2,
-                                      std_cxx1x::_3,
+                                      std_cxx11::_1,
+                                      std_cxx11::_2,
+                                      std_cxx11::_3,
                                       previous_time+time_step),
-                      std_cxx1x::bind(&MyClass<dim>::copy_local_to_global,
+                      std_cxx11::bind(&MyClass<dim>::copy_local_to_global,
                                       *this,
-                                      std_cxx1x::_1),
+                                      std_cxx11::_1),
                       per_task_data);
  * @endcode
  * Here, we bind the object, the linearization point argument, and the
  * current time argument to the function before we hand it off to
  * WorkStream::run(). WorkStream::run() will then simply call the
  * function with the cell and scratch and per task objects which will be filled
- * in at the positions indicated by <code>std_cxx1x::_1, std_cxx1x::_2</code>
- * and <code>std_cxx1x::_3</code>.
+ * in at the positions indicated by <code>std_cxx11::_1, std_cxx11::_2</code>
+ * and <code>std_cxx11::_3</code>.
  *
  * There are refinements to the WorkStream::run function shown above.
  * For example, one may realize that the basic idea above can only scale
similarity index 98%
rename from doc/doxygen/headers/std_cxx1x.h
rename to doc/doxygen/headers/std_cxx11.h
index 02f038e2ea97d9660be555a22b44167725b1f4e9..6fc77675421256cc9620486fdd4c15de7049f861 100644 (file)
@@ -28,6 +28,6 @@
  *
  * @ingroup CPP11
  */
-namespace std_cxx1x
+namespace std_cxx11
 {
 }
index 51faa4b861c5766aa4b4d7ccf37a8965029ee90f..d79e0ce34cad7f290afe186cf248b21b42fc07b3 100644 (file)
@@ -97,6 +97,14 @@ inconvenience this causes.
 
 
 <ol>
+  <li> Changed: Namespace std_cxx1x has been renamed to namespace
+  std_cxx11 to match the fact that the corresponding C++ standard
+  was approved back in 2011. The old namespace name was retained for
+  backward compatibility but is now deprecated.
+  <br>
+  (Wolfgang Bangerth, 2014/09/01)
+  </li>
+
   <li> New: Most of the operations done on Vector (like add, sadd, etc.) 
   are now vectorized (SIMD) using OpenMP 4.0
   <br>
index b89d5fcc82a217c68a1c1ed477d086813a5e9398..2bc85677130b1de77b221047695d41c7812e8161 100644 (file)
@@ -777,20 +777,20 @@ namespace Step13
 
       WorkStream::run(dof_handler.begin_active(),
                       dof_handler.end(),
-                      std_cxx1x::bind(&Solver<dim>::local_assemble_matrix,
+                      std_cxx11::bind(&Solver<dim>::local_assemble_matrix,
                                       this,
-                                      std_cxx1x::_1,
-                                      std_cxx1x::_2,
-                                      std_cxx1x::_3),
-                      std_cxx1x::bind(&Solver<dim>::copy_local_to_global,
+                                      std_cxx11::_1,
+                                      std_cxx11::_2,
+                                      std_cxx11::_3),
+                      std_cxx11::bind(&Solver<dim>::copy_local_to_global,
                                       this,
-                                      std_cxx1x::_1,
-                                      std_cxx1x::ref(linear_system)),
+                                      std_cxx11::_1,
+                                      std_cxx11::ref(linear_system)),
                       AssemblyScratchData(*fe, *quadrature),
                       AssemblyCopyData());
       linear_system.hanging_node_constraints.condense (linear_system.matrix);
 
-      // The syntax above using <code>std_cxx1x::bind</code> requires
+      // The syntax above using <code>std_cxx11::bind</code> requires
       // some explanation. There are multiple version of
       // WorkStream::run that expect different arguments. In step-9,
       // we used one version that took a pair of iterators, a pair of
@@ -824,7 +824,7 @@ namespace Step13
       // typical way to generate such function objects is using
       // <code>std::bind</code> (or, if the compiler is too old, a
       // replacement for it, which we generically call
-      // <code>std_cxx1x::bind</code>) which takes a pointer to a
+      // <code>std_cxx11::bind</code>) which takes a pointer to a
       // (member) function and then <i>binds</i> individual arguments
       // to fixed values. For example, you can create a function that
       // takes an iterator, a scratch object and a copy object by
@@ -840,9 +840,9 @@ namespace Step13
       // that can then be filled by WorkStream::run().
       //
       // There remains the question of what the
-      // <code>std_cxx1x::_1</code>, <code>std_cxx1x::_2</code>, etc.,
+      // <code>std_cxx11::_1</code>, <code>std_cxx11::_2</code>, etc.,
       // mean. (These arguments are called <i>placeholders</i>.) The
-      // idea of using <code>std_cxx1x::bind</code> in the first of
+      // idea of using <code>std_cxx11::bind</code> in the first of
       // the two cases above is that it produces an object that can be
       // called with three arguments. But how are the three arguments
       // the function object is being called with going to be
@@ -855,9 +855,9 @@ namespace Step13
       // games in other circumstances. Consider, for example, having a
       // function <code>void f(double x, double y)</code>. Then,
       // creating a variable <code>p</code> of type
-      // <code>std_cxx1x::function@<void f(double,double)@></code> and
-      // initializing <code>p=std_cxx1x::bind(&f, std_cxx1x::_2,
-      // std_cxx1x::_1)</code> then calling <code>p(1,2)</code> will
+      // <code>std_cxx11::function@<void f(double,double)@></code> and
+      // initializing <code>p=std_cxx11::bind(&f, std_cxx11::_2,
+      // std_cxx11::_1)</code> then calling <code>p(1,2)</code> will
       // result in calling <code>f(2,1)</code>.
       //
       // @note Once deal.II can rely on every compiler being able to
@@ -1033,8 +1033,8 @@ namespace Step13
         = &DoFTools::make_hanging_node_constraints;
 
       // Start a side task then continue on the main thread
-      Threads::Task<> side_task(std_cxx1x::bind(mhnc_p,std_cxx1x::cref(dof_handler),
-                                                std_cxx1x::ref(hanging_node_constraints)));
+      Threads::Task<> side_task(std_cxx11::bind(mhnc_p,std_cxx11::cref(dof_handler),
+                                                std_cxx11::ref(hanging_node_constraints)));
 
       sparsity_pattern.reinit (dof_handler.n_dofs(),
                                dof_handler.n_dofs(),
index bcb7d493edd80de2fd906bf000325d44f4b7d50d..317168cc7277e53669b2e9bb54271d0a68887234 100644 (file)
@@ -573,15 +573,15 @@ namespace Step14
 
       WorkStream::run(dof_handler.begin_active(),
                       dof_handler.end(),
-                      std_cxx1x::bind(&Solver<dim>::local_assemble_matrix,
+                      std_cxx11::bind(&Solver<dim>::local_assemble_matrix,
                                       this,
-                                      std_cxx1x::_1,
-                                      std_cxx1x::_2,
-                                      std_cxx1x::_3),
-                      std_cxx1x::bind(&Solver<dim>::copy_local_to_global,
+                                      std_cxx11::_1,
+                                      std_cxx11::_2,
+                                      std_cxx11::_3),
+                      std_cxx11::bind(&Solver<dim>::copy_local_to_global,
                                       this,
-                                      std_cxx1x::_1,
-                                      std_cxx1x::ref(linear_system)),
+                                      std_cxx11::_1,
+                                      std_cxx11::ref(linear_system)),
                       AssemblyScratchData(*fe, *quadrature),
                       AssemblyCopyData());
 
@@ -2055,7 +2055,7 @@ namespace Step14
       // in step-9:
       void estimate_error (Vector<float> &error_indicators) const;
 
-      void estimate_on_one_cell (const SynchronousIterators<std_cxx1x::tuple<
+      void estimate_on_one_cell (const SynchronousIterators<std_cxx11::tuple<
                                  active_cell_iterator,Vector<float>::iterator> > &cell_and_error,
                                  WeightedResidualScratchData                     &scratch_data,
                                  WeightedResidualCopyData                        &copy_data,
@@ -2066,7 +2066,7 @@ namespace Step14
       // interiors, on those faces that have no hanging nodes, and on those
       // faces with hanging nodes, respectively:
       void
-      integrate_over_cell (const SynchronousIterators<std_cxx1x::tuple<
+      integrate_over_cell (const SynchronousIterators<std_cxx11::tuple<
                            active_cell_iterator,Vector<float>::iterator> > &cell_and_error,
                            const Vector<double>                            &primal_solution,
                            const Vector<double>                            &dual_weights,
@@ -2504,7 +2504,7 @@ namespace Step14
                                .get_tria().n_active_cells());
 
       typedef
-      std_cxx1x::tuple<active_cell_iterator,Vector<float>::iterator>
+      std_cxx11::tuple<active_cell_iterator,Vector<float>::iterator>
       IteratorTuple;
 
       SynchronousIterators<IteratorTuple>
@@ -2516,13 +2516,13 @@ namespace Step14
 
       WorkStream::run(cell_and_error_begin,
                       cell_and_error_end,
-                      std_cxx1x::bind(&WeightedResidual<dim>::estimate_on_one_cell,
+                      std_cxx11::bind(&WeightedResidual<dim>::estimate_on_one_cell,
                                       this,
-                                      std_cxx1x::_1,
-                                      std_cxx1x::_2,
-                                      std_cxx1x::_3,
-                                      std_cxx1x::ref(face_integrals)),
-                      std_cxx1x::function<void (const WeightedResidualCopyData &)>(),
+                                      std_cxx11::_1,
+                                      std_cxx11::_2,
+                                      std_cxx11::_3,
+                                      std_cxx11::ref(face_integrals)),
+                      std_cxx11::function<void (const WeightedResidualCopyData &)>(),
                       WeightedResidualScratchData (primal_solver,
                                                    dual_solver,
                                                    primal_solution,
@@ -2563,7 +2563,7 @@ namespace Step14
     template <int dim>
     void
     WeightedResidual<dim>::
-    estimate_on_one_cell (const SynchronousIterators<std_cxx1x::tuple<
+    estimate_on_one_cell (const SynchronousIterators<std_cxx11::tuple<
                           active_cell_iterator,Vector<float>::iterator> > &cell_and_error,
                           WeightedResidualScratchData                       &scratch_data,
                           WeightedResidualCopyData                          &copy_data,
@@ -2572,7 +2572,7 @@ namespace Step14
       // First task on each cell is to compute the cell residual
       // contributions of this cell, and put them into the
       // <code>error_indicators</code> variable:
-      active_cell_iterator cell = std_cxx1x::get<0>(cell_and_error.iterators);
+      active_cell_iterator cell = std_cxx11::get<0>(cell_and_error.iterators);
 
       integrate_over_cell (cell_and_error,
                            scratch_data.primal_solution,
@@ -2651,7 +2651,7 @@ namespace Step14
     // the cell terms:
     template <int dim>
     void WeightedResidual<dim>::
-    integrate_over_cell (const SynchronousIterators<std_cxx1x::tuple<
+    integrate_over_cell (const SynchronousIterators<std_cxx11::tuple<
                          active_cell_iterator,Vector<float>::iterator> >   &cell_and_error,
                          const Vector<double>                              &primal_solution,
                          const Vector<double>                              &dual_weights,
@@ -2661,7 +2661,7 @@ namespace Step14
       // error estimation formula: first get the right hand side and Laplacian
       // of the numerical solution at the quadrature points for the cell
       // residual,
-      cell_data.fe_values.reinit (std_cxx1x::get<0>(cell_and_error.iterators));
+      cell_data.fe_values.reinit (std_cxx11::get<0>(cell_and_error.iterators));
       cell_data.right_hand_side
       ->value_list (cell_data.fe_values.get_quadrature_points(),
                     cell_data.rhs_values);
@@ -2679,7 +2679,7 @@ namespace Step14
         sum += ((cell_data.rhs_values[p]+cell_data.cell_laplacians[p]) *
                 cell_data.dual_weights[p] *
                 cell_data.fe_values.JxW (p));
-      *(std_cxx1x::get<1>(cell_and_error.iterators)) += sum;
+      *(std_cxx11::get<1>(cell_and_error.iterators)) += sum;
     }
 
 
index 0088538e07793a5d265754012606b22773696e28..868fd467a41667372e93d00c975d39190a802928 100644 (file)
@@ -149,7 +149,7 @@ namespace Step22
     // in how many places a preconditioner object is still referenced, it can
     // never create a memory leak, and can never produce a dangling pointer to
     // an already destroyed object:
-    std_cxx1x::shared_ptr<typename InnerPreconditioner<dim>::type> A_preconditioner;
+    std_cxx11::shared_ptr<typename InnerPreconditioner<dim>::type> A_preconditioner;
   };
 
   // @sect3{Boundary values and right hand side}
@@ -735,7 +735,7 @@ namespace Step22
     std::cout << "   Computing preconditioner..." << std::endl << std::flush;
 
     A_preconditioner
-      = std_cxx1x::shared_ptr<typename InnerPreconditioner<dim>::type>(new typename InnerPreconditioner<dim>::type());
+      = std_cxx11::shared_ptr<typename InnerPreconditioner<dim>::type>(new typename InnerPreconditioner<dim>::type());
     A_preconditioner->initialize (system_matrix.block(0,0),
                                   typename InnerPreconditioner<dim>::type::AdditionalData());
 
index c40b9bd5a6e75a322e2ecaf3fa3a94d3061b1db7..8e7580801f8312fe4d7999af0a875b136cae4b37 100644 (file)
@@ -530,8 +530,8 @@ namespace Step31
     double                              old_time_step;
     unsigned int                        timestep_number;
 
-    std_cxx1x::shared_ptr<TrilinosWrappers::PreconditionAMG> Amg_preconditioner;
-    std_cxx1x::shared_ptr<TrilinosWrappers::PreconditionIC>  Mp_preconditioner;
+    std_cxx11::shared_ptr<TrilinosWrappers::PreconditionAMG> Amg_preconditioner;
+    std_cxx11::shared_ptr<TrilinosWrappers::PreconditionIC>  Mp_preconditioner;
 
     bool                                rebuild_stokes_matrix;
     bool                                rebuild_temperature_matrices;
@@ -1176,7 +1176,7 @@ namespace Step31
 
     assemble_stokes_preconditioner ();
 
-    Amg_preconditioner = std_cxx1x::shared_ptr<TrilinosWrappers::PreconditionAMG>
+    Amg_preconditioner = std_cxx11::shared_ptr<TrilinosWrappers::PreconditionAMG>
                          (new TrilinosWrappers::PreconditionAMG());
 
     std::vector<std::vector<bool> > constant_modes;
@@ -1212,7 +1212,7 @@ namespace Step31
     // (IC) factorization preconditioner, which is designed for symmetric
     // matrices. We could have also chosen an SSOR preconditioner with
     // relaxation factor around 1.2, but IC is cheaper for our example. We
-    // wrap the preconditioners into a <code>std_cxx1x::shared_ptr</code>
+    // wrap the preconditioners into a <code>std_cxx11::shared_ptr</code>
     // pointer, which makes it easier to recreate the preconditioner next time
     // around since we do not have to care about destroying the previously
     // used object.
@@ -1223,7 +1223,7 @@ namespace Step31
     Amg_preconditioner->initialize(stokes_preconditioner_matrix.block(0,0),
                                    amg_data);
 
-    Mp_preconditioner = std_cxx1x::shared_ptr<TrilinosWrappers::PreconditionIC>
+    Mp_preconditioner = std_cxx11::shared_ptr<TrilinosWrappers::PreconditionIC>
                         (new TrilinosWrappers::PreconditionIC());
     Mp_preconditioner->initialize(stokes_preconditioner_matrix.block(1,1));
 
index da200f7edf9c4ffd5a192118aa0ef3ac70a8e37b..0ae17269c6f1dcb564a8bf55453fa4dc32c847c7 100644 (file)
@@ -915,9 +915,9 @@ namespace Step32
     double                                    old_time_step;
     unsigned int                              timestep_number;
 
-    std_cxx1x::shared_ptr<TrilinosWrappers::PreconditionAMG>    Amg_preconditioner;
-    std_cxx1x::shared_ptr<TrilinosWrappers::PreconditionJacobi> Mp_preconditioner;
-    std_cxx1x::shared_ptr<TrilinosWrappers::PreconditionJacobi> T_preconditioner;
+    std_cxx11::shared_ptr<TrilinosWrappers::PreconditionAMG>    Amg_preconditioner;
+    std_cxx11::shared_ptr<TrilinosWrappers::PreconditionJacobi> Mp_preconditioner;
+    std_cxx11::shared_ptr<TrilinosWrappers::PreconditionJacobi> T_preconditioner;
 
     bool                                      rebuild_stokes_matrix;
     bool                                      rebuild_stokes_preconditioner;
@@ -2234,12 +2234,12 @@ namespace Step32
   // specific signatures: three arguments in the first and one
   // argument in the latter case (see the documentation of the
   // WorkStream::run function for the meaning of these arguments).
-  // Note how we use the construct <code>std_cxx1x::bind</code> to
+  // Note how we use the construct <code>std_cxx11::bind</code> to
   // create a function object that satisfies this requirement. It uses
-  // placeholders <code>std_cxx1x::_1, std_cxx1x::_2,
-  // std_cxx1x::_3</code> for the local assembly function that specify
+  // placeholders <code>std_cxx11::_1, std_cxx11::_2,
+  // std_cxx11::_3</code> for the local assembly function that specify
   // cell, scratch data, and copy data, as well as the placeholder
-  // <code>std_cxx1x::_1</code> for the copy function that expects the
+  // <code>std_cxx11::_1</code> for the copy function that expects the
   // data to be written into the global matrix (for placeholder
   // arguments, also see the discussion in step-13's
   // <code>assemble_linear_system()</code> function). On the other
@@ -2281,16 +2281,16 @@ namespace Step32
                      stokes_dof_handler.begin_active()),
          CellFilter (IteratorFilters::LocallyOwnedCell(),
                      stokes_dof_handler.end()),
-         std_cxx1x::bind (&BoussinesqFlowProblem<dim>::
+         std_cxx11::bind (&BoussinesqFlowProblem<dim>::
                           local_assemble_stokes_preconditioner,
                           this,
-                          std_cxx1x::_1,
-                          std_cxx1x::_2,
-                          std_cxx1x::_3),
-         std_cxx1x::bind (&BoussinesqFlowProblem<dim>::
+                          std_cxx11::_1,
+                          std_cxx11::_2,
+                          std_cxx11::_3),
+         std_cxx11::bind (&BoussinesqFlowProblem<dim>::
                           copy_local_to_global_stokes_preconditioner,
                           this,
-                          std_cxx1x::_1),
+                          std_cxx11::_1),
          Assembly::Scratch::
          StokesPreconditioner<dim> (stokes_fe, quadrature_formula,
                                     mapping,
@@ -2472,16 +2472,16 @@ namespace Step32
                      stokes_dof_handler.begin_active()),
          CellFilter (IteratorFilters::LocallyOwnedCell(),
                      stokes_dof_handler.end()),
-         std_cxx1x::bind (&BoussinesqFlowProblem<dim>::
+         std_cxx11::bind (&BoussinesqFlowProblem<dim>::
                           local_assemble_stokes_system,
                           this,
-                          std_cxx1x::_1,
-                          std_cxx1x::_2,
-                          std_cxx1x::_3),
-         std_cxx1x::bind (&BoussinesqFlowProblem<dim>::
+                          std_cxx11::_1,
+                          std_cxx11::_2,
+                          std_cxx11::_3),
+         std_cxx11::bind (&BoussinesqFlowProblem<dim>::
                           copy_local_to_global_stokes_system,
                           this,
-                          std_cxx1x::_1),
+                          std_cxx11::_1),
          Assembly::Scratch::
          StokesSystem<dim> (stokes_fe, mapping, quadrature_formula,
                             (update_values    |
@@ -2593,16 +2593,16 @@ namespace Step32
                      temperature_dof_handler.begin_active()),
          CellFilter (IteratorFilters::LocallyOwnedCell(),
                      temperature_dof_handler.end()),
-         std_cxx1x::bind (&BoussinesqFlowProblem<dim>::
+         std_cxx11::bind (&BoussinesqFlowProblem<dim>::
                           local_assemble_temperature_matrix,
                           this,
-                          std_cxx1x::_1,
-                          std_cxx1x::_2,
-                          std_cxx1x::_3),
-         std_cxx1x::bind (&BoussinesqFlowProblem<dim>::
+                          std_cxx11::_1,
+                          std_cxx11::_2,
+                          std_cxx11::_3),
+         std_cxx11::bind (&BoussinesqFlowProblem<dim>::
                           copy_local_to_global_temperature_matrix,
                           this,
-                          std_cxx1x::_1),
+                          std_cxx11::_1),
          Assembly::Scratch::
          TemperatureMatrix<dim> (temperature_fe, mapping, quadrature_formula),
          Assembly::CopyData::
@@ -2889,19 +2889,19 @@ namespace Step32
                      temperature_dof_handler.begin_active()),
          CellFilter (IteratorFilters::LocallyOwnedCell(),
                      temperature_dof_handler.end()),
-         std_cxx1x::bind (&BoussinesqFlowProblem<dim>::
+         std_cxx11::bind (&BoussinesqFlowProblem<dim>::
                           local_assemble_temperature_rhs,
                           this,
                           global_T_range,
                           maximal_velocity,
                           global_entropy_variation,
-                          std_cxx1x::_1,
-                          std_cxx1x::_2,
-                          std_cxx1x::_3),
-         std_cxx1x::bind (&BoussinesqFlowProblem<dim>::
+                          std_cxx11::_1,
+                          std_cxx11::_2,
+                          std_cxx11::_3),
+         std_cxx11::bind (&BoussinesqFlowProblem<dim>::
                           copy_local_to_global_temperature_rhs,
                           this,
-                          std_cxx1x::_1),
+                          std_cxx11::_1),
          Assembly::Scratch::
          TemperatureRHS<dim> (temperature_fe, stokes_fe, mapping,
                               quadrature_formula),
index f675772db7f6c6494bc56f0a568365bb12a954d1..a625afe5502d6e596bcfee67e8c82c91a0463f66 100644 (file)
@@ -288,7 +288,7 @@ namespace Step34
     Functions::ParsedFunction<dim> exact_solution;
 
     unsigned int singular_quadrature_order;
-    std_cxx1x::shared_ptr<Quadrature<dim-1> > quadrature;
+    std_cxx11::shared_ptr<Quadrature<dim-1> > quadrature;
 
     SolverControl solver_control;
 
@@ -427,7 +427,7 @@ namespace Step34
     prm.enter_subsection("Quadrature rules");
     {
       quadrature =
-        std_cxx1x::shared_ptr<Quadrature<dim-1> >
+        std_cxx11::shared_ptr<Quadrature<dim-1> >
         (new QuadratureSelector<dim-1> (prm.get("Quadrature type"),
                                         prm.get_integer("Quadrature order")));
       singular_quadrature_order = prm.get_integer("Singular quadrature order");
index cd9d97906e797daeef66a3bfbae4a7a2621e849c..a7d9093f59d07c9f42446e300cf21aa67b325025 100644 (file)
@@ -511,7 +511,7 @@ namespace Step35
     // the iterators stored internally is moved up one step as well, thereby
     // always staying in sync. As it so happens, there is a deal.II class that
     // facilitates this sort of thing.
-    typedef std_cxx1x::tuple< typename DoFHandler<dim>::active_cell_iterator,
+    typedef std_cxx11::tuple< typename DoFHandler<dim>::active_cell_iterator,
             typename DoFHandler<dim>::active_cell_iterator
             > IteratorTuple;
 
@@ -892,11 +892,11 @@ namespace Step35
                                  InitGradScratchData &scratch,
                                  InitGradPerTaskData &data)
   {
-    scratch.fe_val_vel.reinit (std_cxx1x::get<0> (SI.iterators));
-    scratch.fe_val_pres.reinit (std_cxx1x::get<1> (SI.iterators));
+    scratch.fe_val_vel.reinit (std_cxx11::get<0> (SI.iterators));
+    scratch.fe_val_pres.reinit (std_cxx11::get<1> (SI.iterators));
 
-    std_cxx1x::get<0> (SI.iterators)->get_dof_indices (data.vel_local_dof_indices);
-    std_cxx1x::get<1> (SI.iterators)->get_dof_indices (data.pres_local_dof_indices);
+    std_cxx11::get<0> (SI.iterators)->get_dof_indices (data.vel_local_dof_indices);
+    std_cxx11::get<1> (SI.iterators)->get_dof_indices (data.pres_local_dof_indices);
 
     data.local_grad = 0.;
     for (unsigned int q=0; q<scratch.nqp; ++q)
index 5b445fd73d5ee1a593b05e1331fed6659aae201a..6c3310a7e72492e2e2bcd9dc75866e18488feadd 100644 (file)
@@ -746,7 +746,7 @@ namespace Step42
     // one shot at setting it; the same is true for the mesh refinement
     // criterion):
     const std::string                                  base_mesh;
-    const std_cxx1x::shared_ptr<const Function<dim> >  obstacle;
+    const std_cxx11::shared_ptr<const Function<dim> >  obstacle;
 
     struct RefinementStrategy
     {
index 5647ece9ec3f5762788afda169fb9003e0de8e28..732dd8992107b0d14764f3ba367cb348ac9d7c72 100644 (file)
@@ -33,7 +33,7 @@
 #include <deal.II/base/utilities.h>
 #include <deal.II/base/function.h>
 #include <deal.II/base/tensor_function.h>
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/solver_gmres.h>
@@ -590,8 +590,8 @@ namespace Step43
     const double                         porosity;
     const double                         AOS_threshold;
 
-    std_cxx1x::shared_ptr<TrilinosWrappers::PreconditionIC> Amg_preconditioner;
-    std_cxx1x::shared_ptr<TrilinosWrappers::PreconditionIC> Mp_preconditioner;
+    std_cxx11::shared_ptr<TrilinosWrappers::PreconditionIC> Amg_preconditioner;
+    std_cxx11::shared_ptr<TrilinosWrappers::PreconditionIC> Mp_preconditioner;
 
     bool                                rebuild_saturation_matrix;
 
@@ -985,11 +985,11 @@ namespace Step43
   {
     assemble_darcy_preconditioner ();
 
-    Amg_preconditioner = std_cxx1x::shared_ptr<TrilinosWrappers::PreconditionIC>
+    Amg_preconditioner = std_cxx11::shared_ptr<TrilinosWrappers::PreconditionIC>
                          (new TrilinosWrappers::PreconditionIC());
     Amg_preconditioner->initialize(darcy_preconditioner_matrix.block(0,0));
 
-    Mp_preconditioner = std_cxx1x::shared_ptr<TrilinosWrappers::PreconditionIC>
+    Mp_preconditioner = std_cxx11::shared_ptr<TrilinosWrappers::PreconditionIC>
                         (new TrilinosWrappers::PreconditionIC());
     Mp_preconditioner->initialize(darcy_preconditioner_matrix.block(1,1));
 
index da6e0628207d6be7bc92da8a631e244ba35246ad..fff4ff53ac6c85557266fad05ca496b9faf074ba 100644 (file)
@@ -1032,10 +1032,10 @@ namespace Step51
 
       WorkStream::run(dof_handler_u_post.begin_active(),
                       dof_handler_u_post.end(),
-                      std_cxx1x::bind (&HDG<dim>::postprocess_one_cell,
-                                       std_cxx1x::ref(*this),
-                                       std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3),
-                      std_cxx1x::function<void(const unsigned int &)>(),
+                      std_cxx11::bind (&HDG<dim>::postprocess_one_cell,
+                                       std_cxx11::ref(*this),
+                                       std_cxx11::_1, std_cxx11::_2, std_cxx11::_3),
+                      std_cxx11::function<void(const unsigned int &)>(),
                       scratch,
                       0U);
     }
index 749901a711752c9d02c2d7d4cfefb2c7100d7229..d7308c9cd8947494a5347309462982840c55890d 100644 (file)
@@ -440,7 +440,7 @@ namespace Step52
     for (unsigned int i=0; i<n_time_steps; ++i)
       {
         time = explicit_runge_kutta.evolve_one_time_step(
-                 std_cxx1x::bind(&Diffusion::evaluate_diffusion,this,std_cxx1x::_1,std_cxx1x::_2),
+                 std_cxx11::bind(&Diffusion::evaluate_diffusion,this,std_cxx11::_1,std_cxx11::_2),
                  time,time_step,solution);
 
         if ((i+1)%10==0)
@@ -468,9 +468,9 @@ namespace Step52
     for (unsigned int i=0; i<n_time_steps; ++i)
       {
         time = implicit_runge_kutta.evolve_one_time_step(
-                 std_cxx1x::bind(&Diffusion::evaluate_diffusion,this,std_cxx1x::_1,std_cxx1x::_2),
-                 std_cxx1x::bind(&Diffusion::id_minus_tau_J_inverse,this,std_cxx1x::_1,std_cxx1x::_2,
-                                 std_cxx1x::_3),
+                 std_cxx11::bind(&Diffusion::evaluate_diffusion,this,std_cxx11::_1,std_cxx11::_2),
+                 std_cxx11::bind(&Diffusion::id_minus_tau_J_inverse,this,std_cxx11::_1,std_cxx11::_2,
+                                 std_cxx11::_3),
                  time,time_step,solution);
 
         if ((i+1)%10==0)
@@ -522,7 +522,7 @@ namespace Step52
           time_step = final_time-time;
 
         time = embedded_explicit_runge_kutta.evolve_one_time_step(
-                 std_cxx1x::bind(&Diffusion::evaluate_diffusion,this,std_cxx1x::_1,std_cxx1x::_2),
+                 std_cxx11::bind(&Diffusion::evaluate_diffusion,this,std_cxx11::_1,std_cxx11::_2),
                  time,time_step,solution);
 
         if ((n_steps+1)%10==0)
index e22d94c79772b192c59a547860b4a82a9c66c5c0..27ff0f0d8b485dfc432069f27813d2f9adfd4426 100644 (file)
@@ -24,7 +24,7 @@
 #include <deal.II/grid/grid_generator.h>
 #include <deal.II/grid/grid_out.h>
 
-#include <deal.II/base/std_cxx1x/array.h>
+#include <deal.II/base/std_cxx11/array.h>
 
 #include <fstream>
 
@@ -46,11 +46,11 @@ public:
   get_new_point_on_quad (const typename Triangulation<dim>::quad_iterator &quad) const;
 private:
 
-  std_cxx1x::array<double,dim> pull_back (const Point<dim> &p) const;
-  Point<dim>                   push_forward (const std_cxx1x::array<double,dim> &preimage) const;
+  std_cxx11::array<double,dim> pull_back (const Point<dim> &p) const;
+  Point<dim>                   push_forward (const std_cxx11::array<double,dim> &preimage) const;
 
   template <int N>
-  static std_cxx1x::array<double,dim> average (const std_cxx1x::array<double,dim> (&array)[N]);
+  static std_cxx11::array<double,dim> average (const std_cxx11::array<double,dim> (&array)[N]);
 
   const Point<dim> center;
 };
@@ -64,7 +64,7 @@ SphereGeometry<dim>::SphereGeometry (const Point<dim> &center)
 
 
 template <>
-std_cxx1x::array<double,2>
+std_cxx11::array<double,2>
 SphereGeometry<2>::pull_back (const Point<2> &p) const
 {
   const Point<2> relative_point = p - center;
@@ -72,7 +72,7 @@ SphereGeometry<2>::pull_back (const Point<2> &p) const
   const double r = relative_point.norm();
   const double phi = std::atan2 (relative_point[1], relative_point[0]);
 
-  std_cxx1x::array<double,2> result;
+  std_cxx11::array<double,2> result;
   result[0] = r;
   result[1] = phi;
 
@@ -82,7 +82,7 @@ SphereGeometry<2>::pull_back (const Point<2> &p) const
 
 template <>
 Point<2>
-SphereGeometry<2>::push_forward (const std_cxx1x::array<double,2> &preimage) const
+SphereGeometry<2>::push_forward (const std_cxx11::array<double,2> &preimage) const
 {
   const Point<2> relative_point = preimage[0] * Point<2>(std::cos(preimage[1]), std::sin(preimage[1]));
 
@@ -92,7 +92,7 @@ SphereGeometry<2>::push_forward (const std_cxx1x::array<double,2> &preimage) con
 
 
 template <>
-std_cxx1x::array<double,3>
+std_cxx11::array<double,3>
 SphereGeometry<3>::pull_back (const Point<3> &p) const
 {
   const Point<3> relative_point = p - center;
@@ -102,7 +102,7 @@ SphereGeometry<3>::pull_back (const Point<3> &p) const
   const double theta = std::atan2 (relative_point[2], std::sqrt (relative_point[0]*relative_point[0] +
                                    relative_point[1]*relative_point[1]));
 
-  std_cxx1x::array<double,3> result;
+  std_cxx11::array<double,3> result;
   result[0] = r;
   result[1] = phi;
   result[2] = theta;
@@ -113,7 +113,7 @@ SphereGeometry<3>::pull_back (const Point<3> &p) const
 
 template <>
 Point<3>
-SphereGeometry<3>::push_forward (const std_cxx1x::array<double,3> &preimage) const
+SphereGeometry<3>::push_forward (const std_cxx11::array<double,3> &preimage) const
 {
   const Point<3> relative_point = (preimage[0] *
                                    Point<3>(std::cos(preimage[1]),
@@ -127,10 +127,10 @@ SphereGeometry<3>::push_forward (const std_cxx1x::array<double,3> &preimage) con
 
 template <>
 template <int N>
-std_cxx1x::array<double,2>
-SphereGeometry<2>::average (const std_cxx1x::array<double,2> (&array)[N])
+std_cxx11::array<double,2>
+SphereGeometry<2>::average (const std_cxx11::array<double,2> (&array)[N])
 {
-  std_cxx1x::array<double,2> result;
+  std_cxx11::array<double,2> result;
 
   // average the radii first. this is uncritical
   {
@@ -179,10 +179,10 @@ SphereGeometry<2>::average (const std_cxx1x::array<double,2> (&array)[N])
 
 template <>
 template <int N>
-std_cxx1x::array<double,3>
-SphereGeometry<3>::average (const std_cxx1x::array<double,3> (&array)[N])
+std_cxx11::array<double,3>
+SphereGeometry<3>::average (const std_cxx11::array<double,3> (&array)[N])
 {
-  std_cxx1x::array<double,3> result;
+  std_cxx11::array<double,3> result;
 
   // average the radii first. this is uncritical
   {
@@ -250,7 +250,7 @@ Point<dim>
 SphereGeometry<dim>::
 get_new_point_on_quad (const typename Triangulation<dim>::quad_iterator &quad) const
 {
-  std_cxx1x::array<double,dim> preimages[4] = { pull_back (quad->vertex(0)),
+  std_cxx11::array<double,dim> preimages[4] = { pull_back (quad->vertex(0)),
                                                 pull_back (quad->vertex(1)),
                                                 pull_back (quad->vertex(2)),
                                                 pull_back (quad->vertex(3))
index eae21871bf01b10b7d2e9dcb0529219e2c80f481..21aae8a5984ac1558a8d3e22a2ce95e83fd26709 100644 (file)
@@ -1,7 +1,7 @@
 /* ---------------------------------------------------------------------
  * $Id$
  *
- * Copyright (C) 2000 - 2013 by the deal.II authors
+ * Copyright (C) 2000 - 2014 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
@@ -515,7 +515,7 @@ namespace Step9
 
     template <int dim>
     static
-    void estimate_cell (const SynchronousIterators<std_cxx1x::tuple<typename DoFHandler<dim>::active_cell_iterator,
+    void estimate_cell (const SynchronousIterators<std_cxx11::tuple<typename DoFHandler<dim>::active_cell_iterator,
                         Vector<float>::iterator> >     &cell,
                         EstimateScratchData<dim>       &scratch_data,
                         const EstimateCopyData         &copy_data);
@@ -1027,7 +1027,7 @@ namespace Step9
             ExcInvalidVectorLength (error_per_cell.size(),
                                     dof_handler.get_tria().n_active_cells()));
 
-    typedef std_cxx1x::tuple<typename DoFHandler<dim>::active_cell_iterator,Vector<float>::iterator>
+    typedef std_cxx11::tuple<typename DoFHandler<dim>::active_cell_iterator,Vector<float>::iterator>
     IteratorTuple;
 
     SynchronousIterators<IteratorTuple>
@@ -1039,7 +1039,7 @@ namespace Step9
     WorkStream::run (begin_sync_it,
                      end_sync_it,
                      &GradientEstimation::template estimate_cell<dim>,
-                     std_cxx1x::function<void (const EstimateCopyData &)> (),
+                     std_cxx11::function<void (const EstimateCopyData &)> (),
                      EstimateScratchData<dim> (dof_handler.get_fe(),
                                                solution),
                      EstimateCopyData ());
@@ -1078,12 +1078,12 @@ namespace Step9
   // passing the following as the third argument when calling WorkStream::run
   // above:
   // @code
-  //    std_cxx1x::function<void (const SynchronousIterators<IteratorTuple> &,
+  //    std_cxx11::function<void (const SynchronousIterators<IteratorTuple> &,
   //                              EstimateScratchData<dim>                  &,
   //                              EstimateCopyData                          &)>
-  //      (std_cxx1x::bind (&GradientEstimation::template estimate_cell<dim>,
-  //                        std_cxx1x::_1,
-  //                        std_cxx1x::_2))
+  //      (std_cxx11::bind (&GradientEstimation::template estimate_cell<dim>,
+  //                        std_cxx11::_1,
+  //                        std_cxx11::_2))
   // @endcode
   // This creates a function object taking three arguments, but when it calls
   // the underlying function object, it simply only uses the first and second
@@ -1094,7 +1094,7 @@ namespace Step9
   // Now for the details:
   template <int dim>
   void
-  GradientEstimation::estimate_cell (const SynchronousIterators<std_cxx1x::tuple<typename DoFHandler<dim>::active_cell_iterator,
+  GradientEstimation::estimate_cell (const SynchronousIterators<std_cxx11::tuple<typename DoFHandler<dim>::active_cell_iterator,
                                      Vector<float>::iterator> > &cell,
                                      EstimateScratchData<dim>                                               &scratch_data,
                                      const EstimateCopyData &)
@@ -1112,7 +1112,7 @@ namespace Step9
     active_neighbors.reserve (GeometryInfo<dim>::faces_per_cell *
                               GeometryInfo<dim>::max_children_per_face);
 
-    typename DoFHandler<dim>::active_cell_iterator cell_it(std_cxx1x::get<0>(cell.iterators));
+    typename DoFHandler<dim>::active_cell_iterator cell_it(std_cxx11::get<0>(cell.iterators));
 
     // First initialize the <code>FEValues</code> object, as well as the
     // <code>Y</code> tensor:
@@ -1147,14 +1147,14 @@ namespace Step9
     // neighbors, of course.
     active_neighbors.clear ();
     for (unsigned int face_no=0; face_no<GeometryInfo<dim>::faces_per_cell; ++face_no)
-      if (! std_cxx1x::get<0>(cell.iterators)->at_boundary(face_no))
+      if (! std_cxx11::get<0>(cell.iterators)->at_boundary(face_no))
         {
           // First define an abbreviation for the iterator to the face and
           // the neighbor
           const typename DoFHandler<dim>::face_iterator
-          face = std_cxx1x::get<0>(cell.iterators)->face(face_no);
+          face = std_cxx11::get<0>(cell.iterators)->face(face_no);
           const typename DoFHandler<dim>::cell_iterator
-          neighbor = std_cxx1x::get<0>(cell.iterators)->neighbor(face_no);
+          neighbor = std_cxx11::get<0>(cell.iterators)->neighbor(face_no);
 
           // Then check whether the neighbor is active. If it is, then it
           // is on the same level or one level coarser (if we are not in
@@ -1197,7 +1197,7 @@ namespace Step9
                   // as an internal error. We therefore use a predefined
                   // exception class to throw here.
                   Assert (neighbor_child->neighbor(face_no==0 ? 1 : 0)
-                          ==std_cxx1x::get<0>(cell.iterators),ExcInternalError());
+                          ==std_cxx11::get<0>(cell.iterators),ExcInternalError());
 
                   // If the check succeeded, we push the active neighbor
                   // we just found to the stack we keep:
@@ -1208,7 +1208,7 @@ namespace Step9
                 // `behind' the subfaces of the current face
                 for (unsigned int subface_no=0; subface_no<face->n_children(); ++subface_no)
                   active_neighbors.push_back (
-                    std_cxx1x::get<0>(cell.iterators)->neighbor_child_on_subface(face_no,subface_no));
+                    std_cxx11::get<0>(cell.iterators)->neighbor_child_on_subface(face_no,subface_no));
             }
         }
 
@@ -1311,7 +1311,7 @@ namespace Step9
     // at the second element of the pair of iterators, which requires
     // slightly awkward syntax but is not otherwise particularly
     // difficult:
-    *(std_cxx1x::get<1>(cell.iterators)) = (std::pow(std_cxx1x::get<0>(cell.iterators)->diameter(),
+    *(std_cxx11::get<1>(cell.iterators)) = (std::pow(std_cxx11::get<0>(cell.iterators)->diameter(),
                                                      1+1.0*dim/2) *
                                             std::sqrt(gradient.square()));
 
index 77ec5a95e1a12f131b64a490b8ded1b6d46dcbf8..a91f2dc38b1a2902581cca4da963c284a95c40a4 100644 (file)
@@ -19,7 +19,7 @@
 #define __deal2__aligned_vector_h
 
 #include <deal.II/base/config.h>
-#include <deal.II/base/std_cxx1x/type_traits.h>
+#include <deal.II/base/std_cxx11/type_traits.h>
 #include <deal.II/base/exceptions.h>
 #include <deal.II/base/memory_consumption.h>
 #include <deal.II/base/parallel.h>
@@ -326,7 +326,7 @@ namespace internal
       // (void*) to silence compiler warning for virtual classes (they will
       // never arrive here because they are non-trivial).
 
-      if (std_cxx1x::is_trivial<T>::value == true)
+      if (std_cxx11::is_trivial<T>::value == true)
         std::memcpy ((void *)(destination_+begin), source_+begin,
                      (end-begin)*sizeof(T));
       else if (copy_only_ == false)
@@ -377,7 +377,7 @@ namespace internal
       // do not use memcmp for long double because on some systems it does not
       // completely fill its memory and may lead to false positives in
       // e.g. valgrind
-      if (std_cxx1x::is_trivial<T>::value == true &&
+      if (std_cxx11::is_trivial<T>::value == true &&
           types_are_equal<T,long double>::value == false)
         {
           const unsigned char zero [sizeof(T)] = {};
@@ -405,7 +405,7 @@ namespace internal
       // element to (void*) to silence compiler warning for virtual
       // classes (they will never arrive here because they are
       // non-trivial).
-      if (std_cxx1x::is_trivial<T>::value == true && trivial_element)
+      if (std_cxx11::is_trivial<T>::value == true && trivial_element)
         std::memset ((void *)(destination_+begin), 0, (end-begin)*sizeof(T));
       else
         // initialize memory and set
@@ -505,7 +505,7 @@ AlignedVector<T>::resize (const size_type size_in,
                           const T        &init)
 {
   const size_type old_size = size();
-  if (std_cxx1x::is_trivial<T>::value == false && size_in < old_size)
+  if (std_cxx11::is_trivial<T>::value == false && size_in < old_size)
     {
       // call destructor on fields that are released
       while (_end_data != _data+size_in)
@@ -579,7 +579,7 @@ AlignedVector<T>::clear ()
 {
   if (_data != 0)
     {
-      if (std_cxx1x::is_trivial<T>::value == false)
+      if (std_cxx11::is_trivial<T>::value == false)
         while (_end_data != _data)
           (--_end_data)->~T();
 
@@ -604,7 +604,7 @@ AlignedVector<T>::push_back (const T in_data)
   Assert (_end_data <= _end_allocated, ExcInternalError());
   if (_end_data == _end_allocated)
     reserve (std::max(2*capacity(),static_cast<size_type>(16)));
-  if (std_cxx1x::is_trivial<T>::value == false)
+  if (std_cxx11::is_trivial<T>::value == false)
     new (_end_data) T;
   *_end_data++ = in_data;
 }
@@ -646,7 +646,7 @@ AlignedVector<T>::insert_back (ForwardIterator begin,
   reserve (old_size + (end-begin));
   for ( ; begin != end; ++begin, ++_end_data)
     {
-      if (std_cxx1x::is_trivial<T>::value == false)
+      if (std_cxx11::is_trivial<T>::value == false)
         new (_end_data) T;
       *_end_data = *begin;
     }
index bd5721e7a870eda3e6b071d4ef0c485b346c6142..625baa1e73816114a54c05fc2407e4cc720e9648 100644 (file)
@@ -22,7 +22,7 @@
 #include <deal.II/base/point.h>
 #include <deal.II/base/table.h>
 #include <deal.II/base/geometry_info.h>
-#include <deal.II/base/std_cxx1x/tuple.h>
+#include <deal.II/base/std_cxx11/tuple.h>
 
 #include <vector>
 #include <string>
@@ -1460,7 +1460,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_dx (const std::vector<Patch<dim,spacedim> > &patches,
                  const std::vector<std::string>          &data_names,
-                 const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                 const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                  const DXFlags                           &flags,
                  std::ostream                            &out);
 
@@ -1514,7 +1514,7 @@ namespace DataOutBase
   template <int spacedim>
   void write_eps (const std::vector<Patch<2,spacedim> > &patches,
                   const std::vector<std::string>          &data_names,
-                  const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                  const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                   const EpsFlags                          &flags,
                   std::ostream                            &out);
 
@@ -1527,7 +1527,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_eps (const std::vector<Patch<dim,spacedim> > &patches,
                   const std::vector<std::string>          &data_names,
-                  const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                  const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                   const EpsFlags                          &flags,
                   std::ostream                            &out);
 
@@ -1545,7 +1545,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_gmv (const std::vector<Patch<dim,spacedim> > &patches,
                   const std::vector<std::string>          &data_names,
-                  const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                  const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                   const GmvFlags                          &flags,
                   std::ostream                            &out);
 
@@ -1612,7 +1612,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_gnuplot (const std::vector<Patch<dim,spacedim> > &patches,
                       const std::vector<std::string>          &data_names,
-                      const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                      const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                       const GnuplotFlags                      &flags,
                       std::ostream                            &out);
 
@@ -1666,7 +1666,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_povray (const std::vector<Patch<dim,spacedim> > &patches,
                      const std::vector<std::string>          &data_names,
-                     const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                     const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                      const PovrayFlags                       &flags,
                      std::ostream                            &out);
 
@@ -1680,7 +1680,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_tecplot (const std::vector<Patch<dim,spacedim> > &patches,
                       const std::vector<std::string>          &data_names,
-                      const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                      const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                       const TecplotFlags                      &flags,
                       std::ostream                            &out);
 
@@ -1709,7 +1709,7 @@ namespace DataOutBase
   void write_tecplot_binary (
     const std::vector<Patch<dim,spacedim> > &patches,
     const std::vector<std::string>          &data_names,
-    const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+    const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
     const TecplotFlags                      &flags,
     std::ostream                            &out);
 
@@ -1731,7 +1731,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_ucd (const std::vector<Patch<dim,spacedim> > &patches,
                   const std::vector<std::string>          &data_names,
-                  const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                  const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                   const UcdFlags                          &flags,
                   std::ostream                            &out);
 
@@ -1757,7 +1757,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_vtk (const std::vector<Patch<dim,spacedim> > &patches,
                   const std::vector<std::string>          &data_names,
-                  const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                  const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                   const VtkFlags                          &flags,
                   std::ostream                            &out);
 
@@ -1789,7 +1789,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_vtu (const std::vector<Patch<dim,spacedim> > &patches,
                   const std::vector<std::string>          &data_names,
-                  const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                  const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                   const VtkFlags                          &flags,
                   std::ostream                            &out);
 
@@ -1819,7 +1819,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_vtu_main (const std::vector<Patch<dim,spacedim> > &patches,
                        const std::vector<std::string>          &data_names,
-                       const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                       const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                        const VtkFlags                          &flags,
                        std::ostream                            &out);
 
@@ -1847,7 +1847,7 @@ namespace DataOutBase
   template <int spacedim>
   void write_svg (const std::vector<Patch<2,spacedim> > &patches,
                   const std::vector<std::string>          &data_names,
-                  const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                  const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                   const SvgFlags                          &flags,
                   std::ostream                            &out);
 
@@ -1895,7 +1895,7 @@ namespace DataOutBase
   void write_deal_II_intermediate (
     const std::vector<Patch<dim,spacedim> > &patches,
     const std::vector<std::string>          &data_names,
-    const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+    const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
     const Deal_II_IntermediateFlags         &flags,
     std::ostream                            &out);
 
@@ -1933,7 +1933,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_filtered_data (const std::vector<Patch<dim,spacedim> > &patches,
                             const std::vector<std::string>          &data_names,
-                            const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                            const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                             DataOutFilter &filtered_data);
 
   /**
@@ -2709,7 +2709,7 @@ protected:
    * collection of scalar fields.
    */
   virtual
-  std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> >
+  std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> >
   get_vector_data_ranges () const;
 
   /**
@@ -2947,7 +2947,7 @@ protected:
    * collection of scalar fields.
    */
   virtual
-  std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> >
+  std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> >
   get_vector_data_ranges () const;
 
 private:
@@ -2962,7 +2962,7 @@ private:
    * Information about whether certain components of the output field
    * are to be considered vectors.
    */
-  std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> >
+  std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> >
   vector_data_ranges;
 };
 
index e3c653fc4bfbf196c84d0784757d5f49efd219da..77294fdabdb83ca812b2c454f9d26a62af481e8d 100644 (file)
@@ -24,7 +24,7 @@
 #include <deal.II/base/subscriptor.h>
 #include <deal.II/base/tensor.h>
 #include <deal.II/base/point.h>
-#include <deal.II/base/std_cxx1x/function.h>
+#include <deal.II/base/std_cxx11/function.h>
 
 #include <vector>
 
@@ -577,9 +577,9 @@ protected:
  * or we could write it like so:
  * @code
  *    ScalarFunctionFromFunctionObject<dim, Number>
- *      my_distance_object (std_cxx1x::bind (&Point<dim, Number>::distance,
+ *      my_distance_object (std_cxx11::bind (&Point<dim, Number>::distance,
  *                                           q,
- *                                           std_cxx1x::_1));
+ *                                           std_cxx11::_1));
  * @endcode
  * The savings in work to write this are apparent.
  *
@@ -593,7 +593,7 @@ public:
    * Given a function object that takes a Point and returns a Number value,
    * convert this into an object that matches the Function<dim, Number> interface.
    */
-  ScalarFunctionFromFunctionObject (const std_cxx1x::function<Number (const Point<dim, Number> &)> &function_object);
+  ScalarFunctionFromFunctionObject (const std_cxx11::function<Number (const Point<dim, Number> &)> &function_object);
 
   /**
    * Return the value of the function at the given point. Returns the value
@@ -607,7 +607,7 @@ private:
    * The function object which we call when this class's value() or
    * value_list() functions are called.
    **/
-  const std_cxx1x::function<Number (const Point<dim, Number> &)> function_object;
+  const std_cxx11::function<Number (const Point<dim, Number> &)> function_object;
 };
 
 
@@ -662,7 +662,7 @@ public:
    * @param selected_component The single component that should be
    *     filled by the first argument.
    **/
-  VectorFunctionFromScalarFunctionObject (const std_cxx1x::function<Number (const Point<dim, Number> &)> &function_object,
+  VectorFunctionFromScalarFunctionObject (const std_cxx11::function<Number (const Point<dim, Number> &)> &function_object,
                                           const unsigned int selected_component,
                                           const unsigned int n_components);
 
@@ -687,7 +687,7 @@ private:
    * The function object which we call when this class's value() or
    * value_list() functions are called.
    **/
-  const std_cxx1x::function<Number (const Point<dim, Number> &)> function_object;
+  const std_cxx11::function<Number (const Point<dim, Number> &)> function_object;
 
   /**
    * The vector component whose value is to be filled by the given scalar
index e75bc47d72bec1a8bc83765295c9115acdf84d96..a12fe26aa9e77d9faf4baf143aff71031ab9ee4e 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 1999 - 2013 by the deal.II authors
+// Copyright (C) 1999 - 2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -23,7 +23,7 @@
 #include <deal.II/base/point.h>
 #include <deal.II/base/table.h>
 
-#include <deal.II/base/std_cxx1x/array.h>
+#include <deal.II/base/std_cxx11/array.h>
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -1229,7 +1229,7 @@ namespace Functions
      *   converting other data types into a table where you specify this
      *   argument.
      */
-    InterpolatedTensorProductGridData (const std_cxx1x::array<std::vector<double>,dim> &coordinate_values,
+    InterpolatedTensorProductGridData (const std_cxx11::array<std::vector<double>,dim> &coordinate_values,
                                        const Table<dim,double>                         &data_values);
 
     /**
@@ -1251,7 +1251,7 @@ namespace Functions
     /**
      * The set of coordinate values in each of the coordinate directions.
      */
-    const std_cxx1x::array<std::vector<double>,dim> coordinate_values;
+    const std_cxx11::array<std::vector<double>,dim> coordinate_values;
 
     /**
      * The data that is to be interpolated.
@@ -1312,8 +1312,8 @@ namespace Functions
      *   converting other data types into a table where you specify this
      *   argument.
      */
-    InterpolatedUniformGridData (const std_cxx1x::array<std::pair<double,double>,dim> &interval_endpoints,
-                                 const std_cxx1x::array<unsigned int,dim>             &n_subintervals,
+    InterpolatedUniformGridData (const std_cxx11::array<std::pair<double,double>,dim> &interval_endpoints,
+                                 const std_cxx11::array<unsigned int,dim>             &n_subintervals,
                                  const Table<dim,double>                              &data_values);
 
     /**
@@ -1335,12 +1335,12 @@ namespace Functions
     /**
      * The set of interval endpoints in each of the coordinate directions.
      */
-    const std_cxx1x::array<std::pair<double,double>,dim> interval_endpoints;
+    const std_cxx11::array<std::pair<double,double>,dim> interval_endpoints;
 
     /**
      * The number of subintervals in each of the coordinate directions.
      */
-    const std_cxx1x::array<unsigned int,dim>             n_subintervals;
+    const std_cxx11::array<unsigned int,dim>             n_subintervals;
 
     /**
      * The data that is to be interpolated.
index f3c58a24b350fdf9a16e2cb036235c9b96a89cf5..8ec3788fd1cacab55b4e0588748280e7d424e5bb 100644 (file)
@@ -21,7 +21,7 @@
 
 #include <deal.II/base/config.h>
 #include <deal.II/base/thread_management.h>
-#include <deal.II/base/std_cxx1x/function.h>
+#include <deal.II/base/std_cxx11/function.h>
 #include <deal.II/dofs/dof_handler.h>
 #include <boost/unordered_map.hpp>
 #include <boost/unordered_set.hpp>
@@ -109,7 +109,7 @@ namespace GraphColoring
     std::vector<std::vector<Iterator> >
     create_partitioning(const Iterator &begin,
                         const typename identity<Iterator>::type &end,
-                        const std_cxx1x::function<std::vector<types::global_dof_index> (const Iterator &)> &get_conflict_indices)
+                        const std_cxx11::function<std::vector<types::global_dof_index> (const Iterator &)> &get_conflict_indices)
     {
       // Number of iterators.
       unsigned int n_iterators = 0;
@@ -212,7 +212,7 @@ namespace GraphColoring
     template <typename Iterator>
     void
     make_dsatur_coloring(std::vector<Iterator> &partition,
-                         const std_cxx1x::function<std::vector<types::global_dof_index> (const Iterator &)> &get_conflict_indices,
+                         const std_cxx11::function<std::vector<types::global_dof_index> (const Iterator &)> &get_conflict_indices,
                          std::vector<std::vector<Iterator> > &partition_coloring)
     {
       partition_coloring.clear ();
@@ -512,7 +512,7 @@ namespace GraphColoring
   std::vector<std::vector<Iterator> >
   make_graph_coloring(const Iterator &begin,
                       const typename identity<Iterator>::type &end,
-                      const std_cxx1x::function<std::vector<types::global_dof_index> (const typename identity<Iterator>::type &)> &get_conflict_indices)
+                      const std_cxx11::function<std::vector<types::global_dof_index> (const typename identity<Iterator>::type &)> &get_conflict_indices)
   {
     Assert (begin != end, ExcMessage ("GraphColoring is not prepared to deal with empty ranges!"));
 
index 2c9519b6d25885c8c6867d780885abb1d9f92ac1..9a7f4fff3a4ad432c74599d25697ff6cb0398b0b 100644 (file)
@@ -20,7 +20,7 @@
 #include <deal.II/base/config.h>
 #include <deal.II/base/exceptions.h>
 #include <deal.II/base/smartpointer.h>
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 #include <deal.II/base/thread_local_storage.h>
 
 #include <string>
@@ -549,7 +549,7 @@ private:
    * We use tbb's thread local storage facility to generate a stringstream
    * for every thread that sends log messages.
    */
-  Threads::ThreadLocalStorage<std_cxx1x::shared_ptr<std::ostringstream> > outstreams;
+  Threads::ThreadLocalStorage<std_cxx11::shared_ptr<std::ostringstream> > outstreams;
 
   template <typename T> friend LogStream &operator << (LogStream &log, const T &t);
 };
index b88f670ca2118ab274abdb2d3ed4712f8579cc88..f7723083cd15226db7e03433a737734f8673388d 100644 (file)
@@ -19,7 +19,7 @@
 
 
 #include <deal.II/base/config.h>
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 
 #include <string>
 #include <complex>
@@ -438,7 +438,7 @@ namespace MemoryConsumption
    */
   template <typename T>
   inline
-  std::size_t memory_consumption (const std_cxx1x::shared_ptr<T> &);
+  std::size_t memory_consumption (const std_cxx11::shared_ptr<T> &);
 }
 
 
@@ -690,9 +690,9 @@ namespace MemoryConsumption
   template <typename T>
   inline
   std::size_t
-  memory_consumption (const std_cxx1x::shared_ptr<T> &)
+  memory_consumption (const std_cxx11::shared_ptr<T> &)
   {
-    return sizeof(std_cxx1x::shared_ptr<T>);
+    return sizeof(std_cxx11::shared_ptr<T>);
   }
 
 
index cbd7a305746eaf68d714a094fd1726456ddef8b6..e43c3699ab08cd612713da7160dc749c4ed583dd 100644 (file)
@@ -20,7 +20,7 @@
 #include <deal.II/base/subscriptor.h>
 #include <vector>
 
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -126,7 +126,7 @@ private:
   /**
    * Array of the objects to be held.
    */
-  std::vector<std_cxx1x::shared_ptr<Object> > objects;
+  std::vector<std_cxx11::shared_ptr<Object> > objects;
 };
 
 
@@ -177,7 +177,7 @@ MGLevelObject<Object>::resize (const unsigned int new_minlevel,
 
   minlevel = new_minlevel;
   for (unsigned int i=0; i<new_maxlevel-new_minlevel+1; ++i)
-    objects.push_back(std_cxx1x::shared_ptr<Object> (new Object));
+    objects.push_back(std_cxx11::shared_ptr<Object> (new Object));
 }
 
 
@@ -185,7 +185,7 @@ template<class Object>
 MGLevelObject<Object> &
 MGLevelObject<Object>::operator = (const double d)
 {
-  typename std::vector<std_cxx1x::shared_ptr<Object> >::iterator v;
+  typename std::vector<std_cxx11::shared_ptr<Object> >::iterator v;
   for (v = objects.begin(); v != objects.end(); ++v)
     **v=d;
   return *this;
@@ -196,7 +196,7 @@ template<class Object>
 void
 MGLevelObject<Object>::clear ()
 {
-  typename std::vector<std_cxx1x::shared_ptr<Object> >::iterator v;
+  typename std::vector<std_cxx11::shared_ptr<Object> >::iterator v;
   for (v = objects.begin(); v != objects.end(); ++v)
     (*v)->clear();
 }
@@ -239,7 +239,7 @@ std::size_t
 MGLevelObject<Object>::memory_consumption () const
 {
   std::size_t result = sizeof(*this);
-  typedef typename std::vector<std_cxx1x::shared_ptr<Object> >::const_iterator Iter;
+  typedef typename std::vector<std_cxx11::shared_ptr<Object> >::const_iterator Iter;
   const Iter end = objects.end();
   for (Iter o=objects.begin(); o!=end; ++o)
     result += (*o)->memory_consumption();
index 9a2e1751750e31b433145635958ae806e1ca4c83..b142c64d0b7b1844690c0d75f1b66dd6a4881cb4 100644 (file)
@@ -23,9 +23,9 @@
 #include <deal.II/base/template_constraints.h>
 #include <deal.II/base/synchronous_iterator.h>
 
-#include <deal.II/base/std_cxx1x/tuple.h>
-#include <deal.II/base/std_cxx1x/bind.h>
-#include <deal.II/base/std_cxx1x/function.h>
+#include <deal.II/base/std_cxx11/tuple.h>
+#include <deal.II/base/std_cxx11/bind.h>
+#include <deal.II/base/std_cxx11/function.h>
 
 #include <cstddef>
 
@@ -86,9 +86,9 @@ namespace parallel
       static
       void
       apply (const F &f,
-             const std_cxx1x::tuple<I1,I2> &p)
+             const std_cxx11::tuple<I1,I2> &p)
       {
-        *std_cxx1x::get<1>(p) = f (*std_cxx1x::get<0>(p));
+        *std_cxx11::get<1>(p) = f (*std_cxx11::get<0>(p));
       }
 
       /**
@@ -99,10 +99,10 @@ namespace parallel
       static
       void
       apply (const F &f,
-             const std_cxx1x::tuple<I1,I2,I3> &p)
+             const std_cxx11::tuple<I1,I2,I3> &p)
       {
-        *std_cxx1x::get<2>(p) = f (*std_cxx1x::get<0>(p),
-                                   *std_cxx1x::get<1>(p));
+        *std_cxx11::get<2>(p) = f (*std_cxx11::get<0>(p),
+                                   *std_cxx11::get<1>(p));
       }
 
       /**
@@ -114,11 +114,11 @@ namespace parallel
       static
       void
       apply (const F &f,
-             const std_cxx1x::tuple<I1,I2,I3,I4> &p)
+             const std_cxx11::tuple<I1,I2,I3,I4> &p)
       {
-        *std_cxx1x::get<3>(p) = f (*std_cxx1x::get<0>(p),
-                                   *std_cxx1x::get<1>(p),
-                                   *std_cxx1x::get<2>(p));
+        *std_cxx11::get<3>(p) = f (*std_cxx11::get<0>(p),
+                                   *std_cxx11::get<1>(p),
+                                   *std_cxx11::get<2>(p));
       }
     };
 
@@ -189,7 +189,7 @@ namespace parallel
     for (OutputIterator in = begin_in; in != end_in;)
       *out++ = predicate (*in++);
 #else
-    typedef std_cxx1x::tuple<InputIterator,OutputIterator> Iterators;
+    typedef std_cxx11::tuple<InputIterator,OutputIterator> Iterators;
     typedef SynchronousIterators<Iterators> SyncIterators;
     Iterators x_begin (begin_in, out);
     Iterators x_end (end_in, OutputIterator());
@@ -258,7 +258,7 @@ namespace parallel
       *out++ = predicate (*in1++, *in2++);
 #else
     typedef
-    std_cxx1x::tuple<InputIterator1,InputIterator2,OutputIterator>
+    std_cxx11::tuple<InputIterator1,InputIterator2,OutputIterator>
     Iterators;
     typedef SynchronousIterators<Iterators> SyncIterators;
     Iterators x_begin (begin_in1, in2, out);
@@ -328,7 +328,7 @@ namespace parallel
       *out++ = predicate (*in1++, *in2++, *in3++);
 #else
     typedef
-    std_cxx1x::tuple<InputIterator1,InputIterator2,InputIterator3,OutputIterator>
+    std_cxx11::tuple<InputIterator1,InputIterator2,InputIterator3,OutputIterator>
     Iterators;
     typedef SynchronousIterators<Iterators> SyncIterators;
     Iterators x_begin (begin_in1, in2, in3, out);
@@ -401,11 +401,11 @@ namespace parallel
    *   {
    *     parallel::apply_to_subranges
    *        (0, A.n_rows(),
-   *         std_cxx1x::bind (&mat_vec_on_subranges,
-   *                          std_cxx1x::_1, std_cxx1x::_2,
-   *                          std_cxx1x::cref(A),
-   *                          std_cxx1x::cref(x),
-   *                          std_cxx1x::ref(y)),
+   *         std_cxx11::bind (&mat_vec_on_subranges,
+   *                          std_cxx11::_1, std_cxx11::_2,
+   *                          std_cxx11::cref(A),
+   *                          std_cxx11::cref(x),
+   *                          std_cxx11::ref(y)),
    *         50);
    *   }
    *
@@ -422,14 +422,14 @@ namespace parallel
    * @endcode
    *
    * Note how we use the
-   * <code>std_cxx1x::bind</code> function to
+   * <code>std_cxx11::bind</code> function to
    * convert
    * <code>mat_vec_on_subranged</code> from a
    * function that takes 5 arguments to one
    * taking 2 by binding the remaining
    * arguments (the modifiers
-   * <code>std_cxx1x::ref</code> and
-   * <code>std_cxx1x::cref</code> make sure
+   * <code>std_cxx11::ref</code> and
+   * <code>std_cxx11::cref</code> make sure
    * that the enclosed variables are actually
    * passed by reference and constant
    * reference, rather than by value). The
@@ -482,9 +482,9 @@ namespace parallel
 #else
     tbb::parallel_for (tbb::blocked_range<RangeType>
                        (begin, end, grainsize),
-                       std_cxx1x::bind (&internal::apply_to_subranges<RangeType,Function>,
-                                        std_cxx1x::_1,
-                                        std_cxx1x::cref(f)),
+                       std_cxx11::bind (&internal::apply_to_subranges<RangeType,Function>,
+                                        std_cxx11::_1,
+                                        std_cxx11::cref(f)),
                        tbb::auto_partitioner());
 #endif
   }
@@ -661,7 +661,7 @@ namespace parallel
        * reduce the result of two calls
        * into one number.
        */
-      const std_cxx1x::function<ResultType (ResultType, ResultType)> reductor;
+      const std_cxx11::function<ResultType (ResultType, ResultType)> reductor;
     };
 #endif
   }
@@ -690,10 +690,10 @@ namespace parallel
    *      std::sqrt
    *       (parallel::accumulate_from_subranges<double>
    *        (0, A.n_rows(),
-   *         std_cxx1x::bind (&mat_norm_sqr_on_subranges,
-   *                          std_cxx1x::_1, std_cxx1x::_2,
-   *                          std_cxx1x::cref(A),
-   *                          std_cxx1x::cref(x)),
+   *         std_cxx11::bind (&mat_norm_sqr_on_subranges,
+   *                          std_cxx11::_1, std_cxx11::_2,
+   *                          std_cxx11::cref(A),
+   *                          std_cxx11::cref(x)),
    *         50);
    *   }
    *
index d2c83943068a02dad446c203676ed80260dd1d1d..cb8b963983bb57f50b09e0e77242c43e3e023c3b 100644 (file)
@@ -21,7 +21,7 @@
 #include <deal.II/base/config.h>
 #include <deal.II/base/exceptions.h>
 #include <deal.II/base/subscriptor.h>
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 
 #include <boost/property_tree/ptree_fwd.hpp>
 #include <boost/serialization/split_member.hpp>
@@ -1934,7 +1934,7 @@ private:
    * A list of patterns that are used to describe the parameters of this
    * object. The are indexed by nodes in the property tree.
    */
-  std::vector<std_cxx1x::shared_ptr<const Patterns::PatternBase> > patterns;
+  std::vector<std_cxx11::shared_ptr<const Patterns::PatternBase> > patterns;
 
   /**
    * Mangle a string so that it doesn't contain any special characters or
@@ -2435,7 +2435,7 @@ ParameterHandler::load (Archive &ar, const unsigned int)
 
   patterns.clear ();
   for (unsigned int j=0; j<descriptions.size(); ++j)
-    patterns.push_back (std_cxx1x::shared_ptr<const Patterns::PatternBase>(Patterns::pattern_factory(descriptions[j])));
+    patterns.push_back (std_cxx11::shared_ptr<const Patterns::PatternBase>(Patterns::pattern_factory(descriptions[j])));
 }
 
 
index 49b75b09c283b87ef253f53879561ff1c04f1748..9b00329c01e387c2e4da1c9a610a427030537e19 100644 (file)
@@ -23,7 +23,7 @@
 #include <deal.II/base/exceptions.h>
 #include <deal.II/base/subscriptor.h>
 #include <deal.II/base/point.h>
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 
 #include <vector>
 
@@ -398,7 +398,7 @@ namespace Polynomials
     /**
      * Coefficients for the interval $[0,1]$.
      */
-    static std::vector<std_cxx1x::shared_ptr<const std::vector<double> > > shifted_coefficients;
+    static std::vector<std_cxx11::shared_ptr<const std::vector<double> > > shifted_coefficients;
 
     /**
      * Vector with already computed
@@ -413,7 +413,7 @@ namespace Polynomials
      * free the memory of the vectors when
      * the global destructor is called.
      */
-    static std::vector<std_cxx1x::shared_ptr<const std::vector<double> > > recursive_coefficients;
+    static std::vector<std_cxx11::shared_ptr<const std::vector<double> > > recursive_coefficients;
 
     /**
      * Compute coefficients recursively.
@@ -594,7 +594,7 @@ namespace Polynomials
      * free the memory of the vectors when
      * the global destructor is called.
      */
-    static std::vector<std_cxx1x::shared_ptr<const std::vector<double> > > recursive_coefficients;
+    static std::vector<std_cxx11::shared_ptr<const std::vector<double> > > recursive_coefficients;
   };
 
 
diff --git a/include/deal.II/base/std_cxx11/array.h b/include/deal.II/base/std_cxx11/array.h
new file mode 100644 (file)
index 0000000..05e94ad
--- /dev/null
@@ -0,0 +1,45 @@
+// ---------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 2009 - 2013 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+#ifndef __deal2__std_cxx11_array_h
+#define __deal2__std_cxx11_array_h
+
+
+#include <deal.II/base/config.h>
+
+#ifdef DEAL_II_WITH_CXX11
+
+#  include <array>
+DEAL_II_NAMESPACE_OPEN
+namespace std_cxx11
+{
+  using std::array;
+}
+DEAL_II_NAMESPACE_CLOSE
+
+#else
+
+#include <boost/array.hpp>
+DEAL_II_NAMESPACE_OPEN
+namespace std_cxx11
+{
+  using boost::array;
+}
+DEAL_II_NAMESPACE_CLOSE
+
+#endif
+
+#endif
diff --git a/include/deal.II/base/std_cxx11/bind.h b/include/deal.II/base/std_cxx11/bind.h
new file mode 100644 (file)
index 0000000..da6cc9a
--- /dev/null
@@ -0,0 +1,70 @@
+// ---------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 2009 - 2013 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+#ifndef __deal2__std_cxx11_bind_h
+#define __deal2__std_cxx11_bind_h
+
+
+#include <deal.II/base/config.h>
+
+#ifdef DEAL_II_WITH_CXX11
+
+#  include <functional>
+
+DEAL_II_NAMESPACE_OPEN
+// in boost, the placeholders _1, _2, ... are in the global namespace. in
+// C++0x, they are in namespace std::placeholders, which makes them awkward to
+// use. import them into the deal.II::std_cxx11 namespace instead and do them
+// same below if we use boost instead.
+namespace std_cxx11
+{
+  using namespace std::placeholders;
+  using std::bind;
+  using std::ref;
+  using std::cref;
+  using std::reference_wrapper;
+}
+DEAL_II_NAMESPACE_CLOSE
+
+#else
+
+#include <boost/bind.hpp>
+
+DEAL_II_NAMESPACE_OPEN
+namespace std_cxx11
+{
+  using boost::bind;
+  using boost::ref;
+  using boost::cref;
+  using boost::reference_wrapper;
+  
+  // now also import the _1, _2 placeholders from the global namespace
+  // into the current one as suggested above
+  using ::_1;
+  using ::_2;
+  using ::_3;
+  using ::_4;
+  using ::_5;
+  using ::_6;
+  using ::_7;
+  using ::_8;
+  using ::_9;
+}
+DEAL_II_NAMESPACE_CLOSE
+
+#endif
+
+#endif
diff --git a/include/deal.II/base/std_cxx11/condition_variable.h b/include/deal.II/base/std_cxx11/condition_variable.h
new file mode 100644 (file)
index 0000000..83a3cfb
--- /dev/null
@@ -0,0 +1,49 @@
+// ---------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 2009 - 2013 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+#ifndef __deal2__std_cxx11_condition_variable_h
+#define __deal2__std_cxx11_condition_variable_h
+
+
+#include <deal.II/base/config.h>
+
+#ifdef DEAL_II_WITH_CXX11
+
+#  include <condition_variable>
+DEAL_II_NAMESPACE_OPEN
+namespace std_cxx11
+{
+  using std::condition_variable;
+  using std::unique_lock;
+  using std::adopt_lock;
+}
+DEAL_II_NAMESPACE_CLOSE
+
+#else
+
+#  include <boost/thread/condition_variable.hpp>
+DEAL_II_NAMESPACE_OPEN
+namespace std_cxx11
+{
+  using boost::condition_variable;
+  using boost::unique_lock;
+  using boost::adopt_lock;
+}
+DEAL_II_NAMESPACE_CLOSE
+
+#endif
+
+#endif
diff --git a/include/deal.II/base/std_cxx11/function.h b/include/deal.II/base/std_cxx11/function.h
new file mode 100644 (file)
index 0000000..765a092
--- /dev/null
@@ -0,0 +1,45 @@
+// ---------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 2009 - 2013 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+#ifndef __deal2__std_cxx11_function_h
+#define __deal2__std_cxx11_function_h
+
+
+#include <deal.II/base/config.h>
+
+#ifdef DEAL_II_WITH_CXX11
+
+#  include <functional>
+DEAL_II_NAMESPACE_OPEN
+namespace std_cxx11
+{
+  using std::function;
+}
+DEAL_II_NAMESPACE_CLOSE
+
+#else
+
+#include <boost/function.hpp>
+DEAL_II_NAMESPACE_OPEN
+namespace std_cxx11
+{
+  using boost::function;
+}
+DEAL_II_NAMESPACE_CLOSE
+
+#endif
+
+#endif
diff --git a/include/deal.II/base/std_cxx11/mutex.h b/include/deal.II/base/std_cxx11/mutex.h
new file mode 100644 (file)
index 0000000..bb8a714
--- /dev/null
@@ -0,0 +1,45 @@
+// ---------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 2009 - 2013 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+#ifndef __deal2__std_cxx11_mutex_h
+#define __deal2__std_cxx11_mutex_h
+
+
+#include <deal.II/base/config.h>
+
+#ifdef DEAL_II_WITH_CXX11
+
+#  include <mutex>
+DEAL_II_NAMESPACE_OPEN
+namespace std_cxx11
+{
+  using std::mutex;
+}
+DEAL_II_NAMESPACE_CLOSE
+
+#else
+
+#  include <boost/thread/mutex.hpp>
+DEAL_II_NAMESPACE_OPEN
+namespace std_cxx11
+{
+  using boost::mutex;
+}
+DEAL_II_NAMESPACE_CLOSE
+
+#endif
+
+#endif
diff --git a/include/deal.II/base/std_cxx11/shared_ptr.h b/include/deal.II/base/std_cxx11/shared_ptr.h
new file mode 100644 (file)
index 0000000..95ba2a2
--- /dev/null
@@ -0,0 +1,48 @@
+// ---------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 2009 - 2013 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+#ifndef __deal2__std_cxx11_shared_ptr_h
+#define __deal2__std_cxx11_shared_ptr_h
+
+
+#include <deal.II/base/config.h>
+
+#ifdef DEAL_II_WITH_CXX11
+
+#  include <memory>
+DEAL_II_NAMESPACE_OPEN
+namespace std_cxx11
+{
+  using std::shared_ptr;
+  using std::enable_shared_from_this;
+}
+DEAL_II_NAMESPACE_CLOSE
+
+#else
+
+#include <boost/shared_ptr.hpp>
+#include <boost/enable_shared_from_this.hpp>
+DEAL_II_NAMESPACE_OPEN
+namespace std_cxx11
+{
+  using boost::shared_ptr;
+  using boost::enable_shared_from_this;
+}
+DEAL_II_NAMESPACE_CLOSE
+
+#endif
+
+#endif
diff --git a/include/deal.II/base/std_cxx11/thread.h b/include/deal.II/base/std_cxx11/thread.h
new file mode 100644 (file)
index 0000000..19276fb
--- /dev/null
@@ -0,0 +1,45 @@
+// ---------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 2009 - 2013 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+#ifndef __deal2__std_cxx11_thread_h
+#define __deal2__std_cxx11_thread_h
+
+
+#include <deal.II/base/config.h>
+
+#ifdef DEAL_II_WITH_CXX11
+
+#  include <thread>
+DEAL_II_NAMESPACE_OPEN
+namespace std_cxx11
+{
+  using std::thread;
+}
+DEAL_II_NAMESPACE_CLOSE
+
+#else
+
+#  include <boost/thread.hpp>
+DEAL_II_NAMESPACE_OPEN
+namespace std_cxx11
+{
+  using boost::thread;
+}
+DEAL_II_NAMESPACE_CLOSE
+
+#endif
+
+#endif
diff --git a/include/deal.II/base/std_cxx11/tuple.h b/include/deal.II/base/std_cxx11/tuple.h
new file mode 100644 (file)
index 0000000..e5c6371
--- /dev/null
@@ -0,0 +1,66 @@
+// ---------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 2009 - 2013 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+#ifndef __deal2__std_cxx11_tuple_h
+#define __deal2__std_cxx11_tuple_h
+
+
+#include <deal.II/base/config.h>
+
+#ifdef DEAL_II_WITH_CXX11
+
+#  include <tuple>
+DEAL_II_NAMESPACE_OPEN
+namespace std_cxx11
+{
+  using std::tuple;
+  using std::get;
+  using std::tuple_size;
+  using std::tuple_element;
+}
+DEAL_II_NAMESPACE_CLOSE
+
+#else
+
+#include <boost/tuple/tuple.hpp>
+DEAL_II_NAMESPACE_OPEN
+namespace std_cxx11
+{
+  using boost::tuple;
+  using boost::get;
+
+                                  // boost::tuples::length has been renamed
+                                  // by the standard to std::tuple_size
+  template <typename T>
+  struct tuple_size 
+  {
+      static const std::size_t value = boost::tuples::length<T>::value;
+  };
+
+                                  // similarly, boost::tuples::element has
+                                  // been renamed by the standard to
+                                  // std::tuple_element
+  template <int N, typename T>
+  struct tuple_element
+  {
+      typedef typename boost::tuples::element<N,T>::type type;
+  };
+}
+DEAL_II_NAMESPACE_CLOSE
+
+#endif
+
+#endif
diff --git a/include/deal.II/base/std_cxx11/type_traits.h b/include/deal.II/base/std_cxx11/type_traits.h
new file mode 100644 (file)
index 0000000..ee98aee
--- /dev/null
@@ -0,0 +1,67 @@
+// ---------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 2012 - 2013 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+#ifndef __deal2__std_cxx11_type_traits_h
+#define __deal2__std_cxx11_type_traits_h
+
+
+#include <deal.II/base/config.h>
+
+#ifdef DEAL_II_WITH_CXX11
+
+#  include <type_traits>
+DEAL_II_NAMESPACE_OPEN
+namespace std_cxx11
+{
+                                // TODO: could fill up with more types from
+                                // C++11 type traits
+  using std::is_pod;
+  using std::is_standard_layout;
+  using std::is_trivial;
+}
+DEAL_II_NAMESPACE_CLOSE
+
+#else
+
+#include <boost/type_traits.hpp>
+DEAL_II_NAMESPACE_OPEN
+namespace std_cxx11
+{
+  using boost::is_pod;
+
+                                // boost does not have is_standard_layout and
+                                // is_trivial, but those are both a subset of
+                                // is_pod
+  template <typename T>
+  struct is_standard_layout
+  {
+    static const bool value = boost::is_pod<T>::value;
+  };
+
+  template <typename T>
+  struct is_trivial
+  {
+    static const bool value = boost::has_trivial_copy<T>::value &&
+      boost::has_trivial_assign<T>::value &&
+      boost::has_trivial_constructor<T>::value &&
+      boost::has_trivial_destructor<T>::value;
+  };
+}
+DEAL_II_NAMESPACE_CLOSE
+
+#endif
+
+#endif
index 22635ef08619865ab96ded4c75af0db7bccd5c4c..326a74e5f440266d0960d4375ce98f1fcc458fda 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2009 - 2013 by the deal.II authors
+// Copyright (C) 2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
 //
 // ---------------------------------------------------------------------
 
-#ifndef __deal2__std_cxx1x_array_h
-#define __deal2__std_cxx1x_array_h
+// this file is deprecated. simply include the one we use now
+#include "../std_cxx11/array.h"
 
-
-#include <deal.II/base/config.h>
-
-#ifdef DEAL_II_WITH_CXX11
-
-#  include <array>
-DEAL_II_NAMESPACE_OPEN
-namespace std_cxx1x
-{
-  using std::array;
-}
-DEAL_II_NAMESPACE_CLOSE
-
-#else
-
-#include <boost/array.hpp>
-DEAL_II_NAMESPACE_OPEN
-namespace std_cxx1x
-{
-  using boost::array;
-}
-DEAL_II_NAMESPACE_CLOSE
-
-#endif
-
-#endif
+// then allow using the old namespace name instead of the new one
+namespace std_cxx1x = std_cxx11;
index 5868fda7d0c3f9a93a5b1f5bd833a33f4087138f..23efb3ad5d857b78078b9f71131ee952dcf96ecd 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2009 - 2013 by the deal.II authors
+// Copyright (C) 2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
 //
 // ---------------------------------------------------------------------
 
-#ifndef __deal2__std_cxx1x_bind_h
-#define __deal2__std_cxx1x_bind_h
+// this file is deprecated. simply include the one we use now
+#include "../std_cxx11/bind.h"
 
-
-#include <deal.II/base/config.h>
-
-#ifdef DEAL_II_WITH_CXX11
-
-#  include <functional>
-
-DEAL_II_NAMESPACE_OPEN
-// in boost, the placeholders _1, _2, ... are in the global namespace. in
-// C++0x, they are in namespace std::placeholders, which makes them awkward to
-// use. import them into the deal.II::std_cxx1x namespace instead and do them
-// same below if we use boost instead.
-namespace std_cxx1x
-{
-  using namespace std::placeholders;
-  using std::bind;
-  using std::ref;
-  using std::cref;
-  using std::reference_wrapper;
-}
-DEAL_II_NAMESPACE_CLOSE
-
-#else
-
-#include <boost/bind.hpp>
-
-DEAL_II_NAMESPACE_OPEN
-namespace std_cxx1x
-{
-  using boost::bind;
-  using boost::ref;
-  using boost::cref;
-  using boost::reference_wrapper;
-  
-  // now also import the _1, _2 placeholders from the global namespace
-  // into the current one as suggested above
-  using ::_1;
-  using ::_2;
-  using ::_3;
-  using ::_4;
-  using ::_5;
-  using ::_6;
-  using ::_7;
-  using ::_8;
-  using ::_9;
-}
-DEAL_II_NAMESPACE_CLOSE
-
-#endif
-
-#endif
+// then allow using the old namespace name instead of the new one
+namespace std_cxx1x = std_cxx11;
index 1927778f1f86a285156d044865d8b191112729a2..dcfa4174cf7a29978a1c0ffbe2113fa6cb9d8477 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2009 - 2013 by the deal.II authors
+// Copyright (C) 2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
 //
 // ---------------------------------------------------------------------
 
-#ifndef __deal2__std_cxx1x_condition_variable_h
-#define __deal2__std_cxx1x_condition_variable_h
+// this file is deprecated. simply include the one we use now
+#include "../std_cxx11/condition_variable.h"
 
-
-#include <deal.II/base/config.h>
-
-#ifdef DEAL_II_WITH_CXX11
-
-#  include <condition_variable>
-DEAL_II_NAMESPACE_OPEN
-namespace std_cxx1x
-{
-  using std::condition_variable;
-  using std::unique_lock;
-  using std::adopt_lock;
-}
-DEAL_II_NAMESPACE_CLOSE
-
-#else
-
-#  include <boost/thread/condition_variable.hpp>
-DEAL_II_NAMESPACE_OPEN
-namespace std_cxx1x
-{
-  using boost::condition_variable;
-  using boost::unique_lock;
-  using boost::adopt_lock;
-}
-DEAL_II_NAMESPACE_CLOSE
-
-#endif
-
-#endif
+// then allow using the old namespace name instead of the new one
+namespace std_cxx1x = std_cxx11;
index 08172582793b363e56745cd3d250b82e8db41ada..323ec322773cf1188f1d5c5d4021ebdfcf481c4c 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2009 - 2013 by the deal.II authors
+// Copyright (C) 2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
 //
 // ---------------------------------------------------------------------
 
-#ifndef __deal2__std_cxx1x_function_h
-#define __deal2__std_cxx1x_function_h
+// this file is deprecated. simply include the one we use now
+#include "../std_cxx11/function.h"
 
-
-#include <deal.II/base/config.h>
-
-#ifdef DEAL_II_WITH_CXX11
-
-#  include <functional>
-DEAL_II_NAMESPACE_OPEN
-namespace std_cxx1x
-{
-  using std::function;
-}
-DEAL_II_NAMESPACE_CLOSE
-
-#else
-
-#include <boost/function.hpp>
-DEAL_II_NAMESPACE_OPEN
-namespace std_cxx1x
-{
-  using boost::function;
-}
-DEAL_II_NAMESPACE_CLOSE
-
-#endif
-
-#endif
+// then allow using the old namespace name instead of the new one
+namespace std_cxx1x = std_cxx11;
index e8b40a54e242abe2e77f582e225ca494bfb71798..a68030ce8060e339c99abc495c5c7eaf3fc7a132 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2009 - 2013 by the deal.II authors
+// Copyright (C) 2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
 //
 // ---------------------------------------------------------------------
 
-#ifndef __deal2__std_cxx1x_mutex_h
-#define __deal2__std_cxx1x_mutex_h
+// this file is deprecated. simply include the one we use now
+#include "../std_cxx11/mutex.h"
 
-
-#include <deal.II/base/config.h>
-
-#ifdef DEAL_II_WITH_CXX11
-
-#  include <mutex>
-DEAL_II_NAMESPACE_OPEN
-namespace std_cxx1x
-{
-  using std::mutex;
-}
-DEAL_II_NAMESPACE_CLOSE
-
-#else
-
-#  include <boost/thread/mutex.hpp>
-DEAL_II_NAMESPACE_OPEN
-namespace std_cxx1x
-{
-  using boost::mutex;
-}
-DEAL_II_NAMESPACE_CLOSE
-
-#endif
-
-#endif
+// then allow using the old namespace name instead of the new one
+namespace std_cxx1x = std_cxx11;
index 78f6701caba48c95c7e0d91a3818bfe7cbbec5df..d7976138596ad8aab49653f05fc4fc446fdbbc79 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2009 - 2013 by the deal.II authors
+// Copyright (C) 2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
 //
 // ---------------------------------------------------------------------
 
-#ifndef __deal2__std_cxx1x_shared_ptr_h
-#define __deal2__std_cxx1x_shared_ptr_h
+// this file is deprecated. simply include the one we use now
+#include "../std_cxx11/shared_ptr.h"
 
-
-#include <deal.II/base/config.h>
-
-#ifdef DEAL_II_WITH_CXX11
-
-#  include <memory>
-DEAL_II_NAMESPACE_OPEN
-namespace std_cxx1x
-{
-  using std::shared_ptr;
-  using std::enable_shared_from_this;
-}
-DEAL_II_NAMESPACE_CLOSE
-
-#else
-
-#include <boost/shared_ptr.hpp>
-#include <boost/enable_shared_from_this.hpp>
-DEAL_II_NAMESPACE_OPEN
-namespace std_cxx1x
-{
-  using boost::shared_ptr;
-  using boost::enable_shared_from_this;
-}
-DEAL_II_NAMESPACE_CLOSE
-
-#endif
-
-#endif
+// then allow using the old namespace name instead of the new one
+namespace std_cxx1x = std_cxx11;
index 2dccd96d78753ac3b7bc5550a0ffe3de9e8c937c..16c428db0c2179479143abde5ebde6e7cda16d4c 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2009 - 2013 by the deal.II authors
+// Copyright (C) 2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
 //
 // ---------------------------------------------------------------------
 
-#ifndef __deal2__std_cxx1x_thread_h
-#define __deal2__std_cxx1x_thread_h
+// this file is deprecated. simply include the one we use now
+#include "../std_cxx11/thread.h"
 
-
-#include <deal.II/base/config.h>
-
-#ifdef DEAL_II_WITH_CXX11
-
-#  include <thread>
-DEAL_II_NAMESPACE_OPEN
-namespace std_cxx1x
-{
-  using std::thread;
-}
-DEAL_II_NAMESPACE_CLOSE
-
-#else
-
-#  include <boost/thread.hpp>
-DEAL_II_NAMESPACE_OPEN
-namespace std_cxx1x
-{
-  using boost::thread;
-}
-DEAL_II_NAMESPACE_CLOSE
-
-#endif
-
-#endif
+// then allow using the old namespace name instead of the new one
+namespace std_cxx1x = std_cxx11;
index 4a23a3d4412f143450df823d845ce95991b0933a..162ee54a3cf848d5dadd9ede310546a8c1769f34 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2009 - 2013 by the deal.II authors
+// Copyright (C) 2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
 //
 // ---------------------------------------------------------------------
 
-#ifndef __deal2__std_cxx1x_tuple_h
-#define __deal2__std_cxx1x_tuple_h
+// this file is deprecated. simply include the one we use now
+#include "../std_cxx11/tuple.h"
 
-
-#include <deal.II/base/config.h>
-
-#ifdef DEAL_II_WITH_CXX11
-
-#  include <tuple>
-DEAL_II_NAMESPACE_OPEN
-namespace std_cxx1x
-{
-  using std::tuple;
-  using std::get;
-  using std::tuple_size;
-  using std::tuple_element;
-}
-DEAL_II_NAMESPACE_CLOSE
-
-#else
-
-#include <boost/tuple/tuple.hpp>
-DEAL_II_NAMESPACE_OPEN
-namespace std_cxx1x
-{
-  using boost::tuple;
-  using boost::get;
-
-                                  // boost::tuples::length has been renamed
-                                  // by the standard to std::tuple_size
-  template <typename T>
-  struct tuple_size 
-  {
-      static const std::size_t value = boost::tuples::length<T>::value;
-  };
-
-                                  // similarly, boost::tuples::element has
-                                  // been renamed by the standard to
-                                  // std::tuple_element
-  template <int N, typename T>
-  struct tuple_element
-  {
-      typedef typename boost::tuples::element<N,T>::type type;
-  };
-}
-DEAL_II_NAMESPACE_CLOSE
-
-#endif
-
-#endif
+// then allow using the old namespace name instead of the new one
+namespace std_cxx1x = std_cxx11;
index d2084bb48b46e449a6da33b4dbb14eb88d327edf..aba163a53539b5645e4b5f53bb7e173fceeab7aa 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2012 - 2013 by the deal.II authors
+// Copyright (C) 2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
 //
 // ---------------------------------------------------------------------
 
-#ifndef __deal2__std_cxx1x_type_traits_h
-#define __deal2__std_cxx1x_type_traits_h
+// this file is deprecated. simply include the one we use now
+#include "../std_cxx11/type_traits.h"
 
+// then allow using the old namespace name instead of the new one
+namespace std_cxx1x = std_cxx11;
 
-#include <deal.II/base/config.h>
-
-#ifdef DEAL_II_WITH_CXX11
-
-#  include <type_traits>
-DEAL_II_NAMESPACE_OPEN
-namespace std_cxx1x
-{
-                                // TODO: could fill up with more types from
-                                // C++11 type traits
-  using std::is_pod;
-  using std::is_standard_layout;
-  using std::is_trivial;
-}
-DEAL_II_NAMESPACE_CLOSE
-
-#else
-
-#include <boost/type_traits.hpp>
-DEAL_II_NAMESPACE_OPEN
-namespace std_cxx1x
-{
-  using boost::is_pod;
-
-                                // boost does not have is_standard_layout and
-                                // is_trivial, but those are both a subset of
-                                // is_pod
-  template <typename T>
-  struct is_standard_layout
-  {
-    static const bool value = boost::is_pod<T>::value;
-  };
-
-  template <typename T>
-  struct is_trivial
-  {
-    static const bool value = boost::has_trivial_copy<T>::value &&
-      boost::has_trivial_assign<T>::value &&
-      boost::has_trivial_constructor<T>::value &&
-      boost::has_trivial_destructor<T>::value;
-  };
-}
-DEAL_II_NAMESPACE_CLOSE
-
-#endif
-
-#endif
index 14b40192ba34f9108421986533bc6f6f102fce3c..3c2aef80bd14020368f7c7d6db2646fad52e1ad8 100644 (file)
@@ -21,7 +21,7 @@
 #include <deal.II/base/config.h>
 #include <deal.II/base/exceptions.h>
 
-#include <deal.II/base/std_cxx1x/tuple.h>
+#include <deal.II/base/std_cxx11/tuple.h>
 
 #include <iterator>
 
@@ -44,7 +44,7 @@ DEAL_II_NAMESPACE_OPEN
  *
  * The template argument of the current
  * class shall be of type
- * <code>std_cxx1x::tuple</code> with
+ * <code>std_cxx11::tuple</code> with
  * arguments equal to the iterator types.
  *
  * This type, and the helper functions
@@ -110,7 +110,7 @@ bool
 operator< (const SynchronousIterators<Iterators> &a,
            const SynchronousIterators<Iterators> &b)
 {
-  return std_cxx1x::get<0>(a.iterators) < std_cxx1x::get<0>(b.iterators);
+  return std_cxx11::get<0>(a.iterators) < std_cxx11::get<0>(b.iterators);
 }
 
 
@@ -129,11 +129,11 @@ std::size_t
 operator- (const SynchronousIterators<Iterators> &a,
            const SynchronousIterators<Iterators> &b)
 {
-  Assert (std::distance (std_cxx1x::get<0>(b.iterators),
-                         std_cxx1x::get<0>(a.iterators)) >= 0,
+  Assert (std::distance (std_cxx11::get<0>(b.iterators),
+                         std_cxx11::get<0>(a.iterators)) >= 0,
           ExcInternalError());
-  return std::distance (std_cxx1x::get<0>(b.iterators),
-                        std_cxx1x::get<0>(a.iterators));
+  return std::distance (std_cxx11::get<0>(b.iterators),
+                        std_cxx11::get<0>(a.iterators));
 }
 
 
@@ -142,11 +142,11 @@ operator- (const SynchronousIterators<Iterators> &a,
  */
 template <typename I1, typename I2>
 inline
-void advance (std_cxx1x::tuple<I1,I2> &t,
+void advance (std_cxx11::tuple<I1,I2> &t,
               const unsigned int       n)
 {
-  std::advance (std_cxx1x::get<0>(t), n);
-  std::advance (std_cxx1x::get<1>(t), n);
+  std::advance (std_cxx11::get<0>(t), n);
+  std::advance (std_cxx11::get<1>(t), n);
 }
 
 /**
@@ -154,12 +154,12 @@ void advance (std_cxx1x::tuple<I1,I2> &t,
  */
 template <typename I1, typename I2, typename I3>
 inline
-void advance (std_cxx1x::tuple<I1,I2,I3> &t,
+void advance (std_cxx11::tuple<I1,I2,I3> &t,
               const unsigned int          n)
 {
-  std::advance (std_cxx1x::get<0>(t), n);
-  std::advance (std_cxx1x::get<1>(t), n);
-  std::advance (std_cxx1x::get<2>(t), n);
+  std::advance (std_cxx11::get<0>(t), n);
+  std::advance (std_cxx11::get<1>(t), n);
+  std::advance (std_cxx11::get<2>(t), n);
 }
 
 /**
@@ -168,13 +168,13 @@ void advance (std_cxx1x::tuple<I1,I2,I3> &t,
 template <typename I1, typename I2,
           typename I3, typename I4>
 inline
-void advance (std_cxx1x::tuple<I1,I2,I3, I4> &t,
+void advance (std_cxx11::tuple<I1,I2,I3, I4> &t,
               const unsigned int              n)
 {
-  std::advance (std_cxx1x::get<0>(t), n);
-  std::advance (std_cxx1x::get<1>(t), n);
-  std::advance (std_cxx1x::get<2>(t), n);
-  std::advance (std_cxx1x::get<3>(t), n);
+  std::advance (std_cxx11::get<0>(t), n);
+  std::advance (std_cxx11::get<1>(t), n);
+  std::advance (std_cxx11::get<2>(t), n);
+  std::advance (std_cxx11::get<3>(t), n);
 }
 
 
@@ -184,10 +184,10 @@ void advance (std_cxx1x::tuple<I1,I2,I3, I4> &t,
  */
 template <typename I1, typename I2>
 inline
-void advance_by_one (std_cxx1x::tuple<I1,I2> &t)
+void advance_by_one (std_cxx11::tuple<I1,I2> &t)
 {
-  ++std_cxx1x::get<0>(t);
-  ++std_cxx1x::get<1>(t);
+  ++std_cxx11::get<0>(t);
+  ++std_cxx11::get<1>(t);
 }
 
 /**
@@ -195,11 +195,11 @@ void advance_by_one (std_cxx1x::tuple<I1,I2> &t)
  */
 template <typename I1, typename I2, typename I3>
 inline
-void advance_by_one (std_cxx1x::tuple<I1,I2,I3> &t)
+void advance_by_one (std_cxx11::tuple<I1,I2,I3> &t)
 {
-  ++std_cxx1x::get<0>(t);
-  ++std_cxx1x::get<1>(t);
-  ++std_cxx1x::get<2>(t);
+  ++std_cxx11::get<0>(t);
+  ++std_cxx11::get<1>(t);
+  ++std_cxx11::get<2>(t);
 }
 
 /**
@@ -208,12 +208,12 @@ void advance_by_one (std_cxx1x::tuple<I1,I2,I3> &t)
 template <typename I1, typename I2,
           typename I3, typename I4>
 inline
-void advance_by_one (std_cxx1x::tuple<I1,I2,I3,I4> &t)
+void advance_by_one (std_cxx11::tuple<I1,I2,I3,I4> &t)
 {
-  ++std_cxx1x::get<0>(t);
-  ++std_cxx1x::get<1>(t);
-  ++std_cxx1x::get<2>(t);
-  ++std_cxx1x::get<3>(t);
+  ++std_cxx11::get<0>(t);
+  ++std_cxx11::get<1>(t);
+  ++std_cxx11::get<2>(t);
+  ++std_cxx11::get<3>(t);
 }
 
 
@@ -259,8 +259,8 @@ bool
 operator != (const SynchronousIterators<Iterators> &a,
              const SynchronousIterators<Iterators> &b)
 {
-  return (std_cxx1x::get<0>(a.iterators) !=
-          std_cxx1x::get<0>(b.iterators));
+  return (std_cxx11::get<0>(a.iterators) !=
+          std_cxx11::get<0>(b.iterators));
 }
 
 DEAL_II_NAMESPACE_CLOSE
index 337e0933f94c5ca32a862e808871cfb8a5002a65..635beef1bb391cc552531974f90659e41eeaef85 100644 (file)
 #include <deal.II/base/config.h>
 #include <deal.II/base/exceptions.h>
 #include <deal.II/base/template_constraints.h>
-#include <deal.II/base/std_cxx1x/tuple.h>
-#include <deal.II/base/std_cxx1x/function.h>
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
-#include <deal.II/base/std_cxx1x/bind.h>
+#include <deal.II/base/std_cxx11/tuple.h>
+#include <deal.II/base/std_cxx11/function.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
+#include <deal.II/base/std_cxx11/bind.h>
 
 #ifdef DEAL_II_WITH_THREADS
-#  include <deal.II/base/std_cxx1x/thread.h>
-#  include <deal.II/base/std_cxx1x/mutex.h>
-#  include <deal.II/base/std_cxx1x/condition_variable.h>
+#  include <deal.II/base/std_cxx11/thread.h>
+#  include <deal.II/base/std_cxx11/mutex.h>
+#  include <deal.II/base/std_cxx11/condition_variable.h>
 #endif
 
 #include <iterator>
@@ -418,7 +418,7 @@ namespace Threads
      * Data object storing the
      * mutex data
      */
-    std_cxx1x::mutex mutex;
+    std_cxx11::mutex mutex;
 
     /**
      * Make the class implementing
@@ -480,8 +480,8 @@ namespace Threads
      */
     inline void wait (Mutex &mutex)
     {
-      std_cxx1x::unique_lock<std_cxx1x::mutex> lock(mutex.mutex,
-                                                    std_cxx1x::adopt_lock);
+      std_cxx11::unique_lock<std_cxx11::mutex> lock(mutex.mutex,
+                                                    std_cxx11::adopt_lock);
       condition_variable.wait (lock);
     }
 
@@ -490,7 +490,7 @@ namespace Threads
      * Data object storing the
      * necessary data.
      */
-    std_cxx1x::condition_variable condition_variable;
+    std_cxx11::condition_variable condition_variable;
   };
 
 
@@ -1002,14 +1002,14 @@ namespace Threads
   namespace internal
   {
     template <typename RT>
-    inline void call (const std_cxx1x::function<RT ()> &function,
+    inline void call (const std_cxx11::function<RT ()> &function,
                       internal::return_value<RT> &ret_val)
     {
       ret_val.set (function());
     }
 
 
-    inline void call (const std_cxx1x::function<void ()> &function,
+    inline void call (const std_cxx11::function<void ()> &function,
                       internal::return_value<void> &)
     {
       function();
@@ -1034,7 +1034,7 @@ namespace Threads
      * for each number of arguments.
      */
     template <typename RT, typename ArgList,
-              int length = std_cxx1x::tuple_size<ArgList>::value>
+              int length = std_cxx11::tuple_size<ArgList>::value>
     struct fun_ptr_helper;
 
 
@@ -1062,7 +1062,7 @@ namespace Threads
     template <typename RT, typename ArgList>
     struct fun_ptr_helper<RT, ArgList, 1>
     {
-      typedef RT (type) (typename std_cxx1x::tuple_element<0,ArgList>::type);
+      typedef RT (type) (typename std_cxx11::tuple_element<0,ArgList>::type);
     };
 
 
@@ -1076,8 +1076,8 @@ namespace Threads
     template <typename RT, typename ArgList>
     struct fun_ptr_helper<RT, ArgList, 2>
     {
-      typedef RT (type) (typename std_cxx1x::tuple_element<0,ArgList>::type,
-                         typename std_cxx1x::tuple_element<1,ArgList>::type);
+      typedef RT (type) (typename std_cxx11::tuple_element<0,ArgList>::type,
+                         typename std_cxx11::tuple_element<1,ArgList>::type);
     };
 
 
@@ -1091,9 +1091,9 @@ namespace Threads
     template <typename RT, typename ArgList>
     struct fun_ptr_helper<RT, ArgList, 3>
     {
-      typedef RT (type) (typename std_cxx1x::tuple_element<0,ArgList>::type,
-                         typename std_cxx1x::tuple_element<1,ArgList>::type,
-                         typename std_cxx1x::tuple_element<2,ArgList>::type);
+      typedef RT (type) (typename std_cxx11::tuple_element<0,ArgList>::type,
+                         typename std_cxx11::tuple_element<1,ArgList>::type,
+                         typename std_cxx11::tuple_element<2,ArgList>::type);
     };
 
 
@@ -1107,10 +1107,10 @@ namespace Threads
     template <typename RT, typename ArgList>
     struct fun_ptr_helper<RT, ArgList, 4>
     {
-      typedef RT (type) (typename std_cxx1x::tuple_element<0,ArgList>::type,
-                         typename std_cxx1x::tuple_element<1,ArgList>::type,
-                         typename std_cxx1x::tuple_element<2,ArgList>::type,
-                         typename std_cxx1x::tuple_element<3,ArgList>::type);
+      typedef RT (type) (typename std_cxx11::tuple_element<0,ArgList>::type,
+                         typename std_cxx11::tuple_element<1,ArgList>::type,
+                         typename std_cxx11::tuple_element<2,ArgList>::type,
+                         typename std_cxx11::tuple_element<3,ArgList>::type);
     };
 
 
@@ -1124,11 +1124,11 @@ namespace Threads
     template <typename RT, typename ArgList>
     struct fun_ptr_helper<RT, ArgList, 5>
     {
-      typedef RT (type) (typename std_cxx1x::tuple_element<0,ArgList>::type,
-                         typename std_cxx1x::tuple_element<1,ArgList>::type,
-                         typename std_cxx1x::tuple_element<2,ArgList>::type,
-                         typename std_cxx1x::tuple_element<3,ArgList>::type,
-                         typename std_cxx1x::tuple_element<4,ArgList>::type);
+      typedef RT (type) (typename std_cxx11::tuple_element<0,ArgList>::type,
+                         typename std_cxx11::tuple_element<1,ArgList>::type,
+                         typename std_cxx11::tuple_element<2,ArgList>::type,
+                         typename std_cxx11::tuple_element<3,ArgList>::type,
+                         typename std_cxx11::tuple_element<4,ArgList>::type);
     };
 
 
@@ -1142,12 +1142,12 @@ namespace Threads
     template <typename RT, typename ArgList>
     struct fun_ptr_helper<RT, ArgList, 6>
     {
-      typedef RT (type) (typename std_cxx1x::tuple_element<0,ArgList>::type,
-                         typename std_cxx1x::tuple_element<1,ArgList>::type,
-                         typename std_cxx1x::tuple_element<2,ArgList>::type,
-                         typename std_cxx1x::tuple_element<3,ArgList>::type,
-                         typename std_cxx1x::tuple_element<4,ArgList>::type,
-                         typename std_cxx1x::tuple_element<5,ArgList>::type);
+      typedef RT (type) (typename std_cxx11::tuple_element<0,ArgList>::type,
+                         typename std_cxx11::tuple_element<1,ArgList>::type,
+                         typename std_cxx11::tuple_element<2,ArgList>::type,
+                         typename std_cxx11::tuple_element<3,ArgList>::type,
+                         typename std_cxx11::tuple_element<4,ArgList>::type,
+                         typename std_cxx11::tuple_element<5,ArgList>::type);
     };
 
 
@@ -1161,13 +1161,13 @@ namespace Threads
     template <typename RT, typename ArgList>
     struct fun_ptr_helper<RT, ArgList, 7>
     {
-      typedef RT (type) (typename std_cxx1x::tuple_element<0,ArgList>::type,
-                         typename std_cxx1x::tuple_element<1,ArgList>::type,
-                         typename std_cxx1x::tuple_element<2,ArgList>::type,
-                         typename std_cxx1x::tuple_element<3,ArgList>::type,
-                         typename std_cxx1x::tuple_element<4,ArgList>::type,
-                         typename std_cxx1x::tuple_element<5,ArgList>::type,
-                         typename std_cxx1x::tuple_element<6,ArgList>::type);
+      typedef RT (type) (typename std_cxx11::tuple_element<0,ArgList>::type,
+                         typename std_cxx11::tuple_element<1,ArgList>::type,
+                         typename std_cxx11::tuple_element<2,ArgList>::type,
+                         typename std_cxx11::tuple_element<3,ArgList>::type,
+                         typename std_cxx11::tuple_element<4,ArgList>::type,
+                         typename std_cxx11::tuple_element<5,ArgList>::type,
+                         typename std_cxx11::tuple_element<6,ArgList>::type);
     };
 
 
@@ -1181,14 +1181,14 @@ namespace Threads
     template <typename RT, typename ArgList>
     struct fun_ptr_helper<RT, ArgList, 8>
     {
-      typedef RT (type) (typename std_cxx1x::tuple_element<0,ArgList>::type,
-                         typename std_cxx1x::tuple_element<1,ArgList>::type,
-                         typename std_cxx1x::tuple_element<2,ArgList>::type,
-                         typename std_cxx1x::tuple_element<3,ArgList>::type,
-                         typename std_cxx1x::tuple_element<4,ArgList>::type,
-                         typename std_cxx1x::tuple_element<5,ArgList>::type,
-                         typename std_cxx1x::tuple_element<6,ArgList>::type,
-                         typename std_cxx1x::tuple_element<7,ArgList>::type);
+      typedef RT (type) (typename std_cxx11::tuple_element<0,ArgList>::type,
+                         typename std_cxx11::tuple_element<1,ArgList>::type,
+                         typename std_cxx11::tuple_element<2,ArgList>::type,
+                         typename std_cxx11::tuple_element<3,ArgList>::type,
+                         typename std_cxx11::tuple_element<4,ArgList>::type,
+                         typename std_cxx11::tuple_element<5,ArgList>::type,
+                         typename std_cxx11::tuple_element<6,ArgList>::type,
+                         typename std_cxx11::tuple_element<7,ArgList>::type);
     };
 
 
@@ -1202,15 +1202,15 @@ namespace Threads
     template <typename RT, typename ArgList>
     struct fun_ptr_helper<RT, ArgList, 9>
     {
-      typedef RT (type) (typename std_cxx1x::tuple_element<0,ArgList>::type,
-                         typename std_cxx1x::tuple_element<1,ArgList>::type,
-                         typename std_cxx1x::tuple_element<2,ArgList>::type,
-                         typename std_cxx1x::tuple_element<3,ArgList>::type,
-                         typename std_cxx1x::tuple_element<4,ArgList>::type,
-                         typename std_cxx1x::tuple_element<5,ArgList>::type,
-                         typename std_cxx1x::tuple_element<6,ArgList>::type,
-                         typename std_cxx1x::tuple_element<7,ArgList>::type,
-                         typename std_cxx1x::tuple_element<8,ArgList>::type);
+      typedef RT (type) (typename std_cxx11::tuple_element<0,ArgList>::type,
+                         typename std_cxx11::tuple_element<1,ArgList>::type,
+                         typename std_cxx11::tuple_element<2,ArgList>::type,
+                         typename std_cxx11::tuple_element<3,ArgList>::type,
+                         typename std_cxx11::tuple_element<4,ArgList>::type,
+                         typename std_cxx11::tuple_element<5,ArgList>::type,
+                         typename std_cxx11::tuple_element<6,ArgList>::type,
+                         typename std_cxx11::tuple_element<7,ArgList>::type,
+                         typename std_cxx11::tuple_element<8,ArgList>::type);
     };
 
 
@@ -1225,16 +1225,16 @@ namespace Threads
     template <typename RT, typename ArgList>
     struct fun_ptr_helper<RT, ArgList, 10>
     {
-      typedef RT (type) (typename std_cxx1x::tuple_element<0,ArgList>::type,
-                         typename std_cxx1x::tuple_element<1,ArgList>::type,
-                         typename std_cxx1x::tuple_element<2,ArgList>::type,
-                         typename std_cxx1x::tuple_element<3,ArgList>::type,
-                         typename std_cxx1x::tuple_element<4,ArgList>::type,
-                         typename std_cxx1x::tuple_element<5,ArgList>::type,
-                         typename std_cxx1x::tuple_element<6,ArgList>::type,
-                         typename std_cxx1x::tuple_element<7,ArgList>::type,
-                         typename std_cxx1x::tuple_element<8,ArgList>::type,
-                         typename std_cxx1x::tuple_element<9,ArgList>::type);
+      typedef RT (type) (typename std_cxx11::tuple_element<0,ArgList>::type,
+                         typename std_cxx11::tuple_element<1,ArgList>::type,
+                         typename std_cxx11::tuple_element<2,ArgList>::type,
+                         typename std_cxx11::tuple_element<3,ArgList>::type,
+                         typename std_cxx11::tuple_element<4,ArgList>::type,
+                         typename std_cxx11::tuple_element<5,ArgList>::type,
+                         typename std_cxx11::tuple_element<6,ArgList>::type,
+                         typename std_cxx11::tuple_element<7,ArgList>::type,
+                         typename std_cxx11::tuple_element<8,ArgList>::type,
+                         typename std_cxx11::tuple_element<9,ArgList>::type);
     };
 
 
@@ -1291,7 +1291,7 @@ namespace Threads
        * An object that represents the
        * thread started.
        */
-      std_cxx1x::thread thread;
+      std_cxx11::thread thread;
 
       /**
        * An object that will hold the value
@@ -1304,7 +1304,7 @@ namespace Threads
        * This makes sure the object stays
        * alive until the thread exits.
        */
-      std_cxx1x::shared_ptr<return_value<RT> > ret_val;
+      std_cxx11::shared_ptr<return_value<RT> > ret_val;
 
       /**
        * A bool variable that is initially
@@ -1388,11 +1388,11 @@ namespace Threads
        * it put its return value
        * into the ret_val object.
        */
-      void start (const std_cxx1x::function<RT ()> &function)
+      void start (const std_cxx11::function<RT ()> &function)
       {
         thread_is_active = true;
         ret_val.reset(new return_value<RT>());
-        thread = std_cxx1x::thread (thread_entry_point, function, ret_val);
+        thread = std_cxx11::thread (thread_entry_point, function, ret_val);
       }
 
 
@@ -1424,8 +1424,8 @@ namespace Threads
        * thread.
        */
       static
-      void thread_entry_point (const std_cxx1x::function<RT ()> function,
-                               std_cxx1x::shared_ptr<return_value<RT> > ret_val)
+      void thread_entry_point (const std_cxx11::function<RT ()> function,
+                               std_cxx11::shared_ptr<return_value<RT> > ret_val)
       {
         // call the function
         // in question. since an
@@ -1477,14 +1477,14 @@ namespace Threads
        * returned by the function called on
        * the thread.
        */
-      std_cxx1x::shared_ptr<return_value<RT> > ret_val;
+      std_cxx11::shared_ptr<return_value<RT> > ret_val;
 
       /**
        * Start the thread and
        * let it put its return value into
        * the ret_val object.
        */
-      void start (const std_cxx1x::function<RT ()> &function)
+      void start (const std_cxx11::function<RT ()> &function)
       {
         ret_val.reset(new return_value<RT>());
         call (function, *ret_val);
@@ -1546,7 +1546,7 @@ namespace Threads
      * Construct a thread object
      * with a function object.
      */
-    Thread (const std_cxx1x::function<RT ()> &function)
+    Thread (const std_cxx11::function<RT ()> &function)
       :
       thread_descriptor (new internal::ThreadDescriptor<RT>())
     {
@@ -1641,7 +1641,7 @@ namespace Threads
      * as long as there is at least
      * one subscriber to it.
      */
-    std_cxx1x::shared_ptr<internal::ThreadDescriptor<RT> > thread_descriptor;
+    std_cxx11::shared_ptr<internal::ThreadDescriptor<RT> > thread_descriptor;
   };
 
 
@@ -1649,7 +1649,7 @@ namespace Threads
   {
     /**
      * A general template that returns
-     * std_cxx1x::ref(t) if t is of reference
+     * std_cxx11::ref(t) if t is of reference
      * type, and t otherwise.
      *
      * The case that t is of reference type
@@ -1669,7 +1669,7 @@ namespace Threads
 
     /**
      * A general template that returns
-     * std_cxx1x::ref(t) if t is of reference
+     * std_cxx11::ref(t) if t is of reference
      * type, and t otherwise.
      *
      * The case that t is of reference type
@@ -1679,9 +1679,9 @@ namespace Threads
     template <typename T>
     struct maybe_make_ref<T &>
     {
-      static std_cxx1x::reference_wrapper<T> act (T &t)
+      static std_cxx11::reference_wrapper<T> act (T &t)
       {
-        return std_cxx1x::ref(t);
+        return std_cxx11::ref(t);
       }
     };
   }
@@ -1733,7 +1733,7 @@ namespace Threads
         : function (*function)
       {}
 
-      fun_encapsulator (const std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
+      fun_encapsulator (const std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
         : function (function)
       {}
 
@@ -1745,7 +1745,7 @@ namespace Threads
       }
 
     private:
-      std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> function;
+      std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> function;
     };
 
     /**
@@ -1761,22 +1761,22 @@ namespace Threads
         : function (*function)
       {}
 
-      fun_encapsulator (const std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
+      fun_encapsulator (const std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
         : function (function)
       {}
 
       inline
       Thread<RT>
-      operator() (typename std_cxx1x::tuple_element<0,ArgList>::type arg1)
+      operator() (typename std_cxx11::tuple_element<0,ArgList>::type arg1)
       {
         return
           Thread<RT>
-          (std_cxx1x::bind (function,
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<0,ArgList>::type>::act(arg1)));
+          (std_cxx11::bind (function,
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<0,ArgList>::type>::act(arg1)));
       }
 
     private:
-      std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> function;
+      std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> function;
     };
 
     /**
@@ -1792,24 +1792,24 @@ namespace Threads
         : function (*function)
       {}
 
-      fun_encapsulator (const std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
+      fun_encapsulator (const std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
         : function (function)
       {}
 
       inline
       Thread<RT>
-      operator() (typename std_cxx1x::tuple_element<0,ArgList>::type arg1,
-                  typename std_cxx1x::tuple_element<1,ArgList>::type arg2)
+      operator() (typename std_cxx11::tuple_element<0,ArgList>::type arg1,
+                  typename std_cxx11::tuple_element<1,ArgList>::type arg2)
       {
         return
           Thread<RT>
-          (std_cxx1x::bind (function,
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<0,ArgList>::type>::act(arg1),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<1,ArgList>::type>::act(arg2)));
+          (std_cxx11::bind (function,
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<0,ArgList>::type>::act(arg1),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<1,ArgList>::type>::act(arg2)));
       }
 
     private:
-      std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> function;
+      std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> function;
     };
 
     /**
@@ -1825,26 +1825,26 @@ namespace Threads
         : function (*function)
       {}
 
-      fun_encapsulator (const std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
+      fun_encapsulator (const std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
         : function (function)
       {}
 
       inline
       Thread<RT>
-      operator() (typename std_cxx1x::tuple_element<0,ArgList>::type arg1,
-                  typename std_cxx1x::tuple_element<1,ArgList>::type arg2,
-                  typename std_cxx1x::tuple_element<2,ArgList>::type arg3)
+      operator() (typename std_cxx11::tuple_element<0,ArgList>::type arg1,
+                  typename std_cxx11::tuple_element<1,ArgList>::type arg2,
+                  typename std_cxx11::tuple_element<2,ArgList>::type arg3)
       {
         return
           Thread<RT>
-          (std_cxx1x::bind (function,
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<0,ArgList>::type>::act(arg1),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<1,ArgList>::type>::act(arg2),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<2,ArgList>::type>::act(arg3)));
+          (std_cxx11::bind (function,
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<0,ArgList>::type>::act(arg1),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<1,ArgList>::type>::act(arg2),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<2,ArgList>::type>::act(arg3)));
       }
 
     private:
-      std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> function;
+      std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> function;
     };
 
     /**
@@ -1860,28 +1860,28 @@ namespace Threads
         : function (*function)
       {}
 
-      fun_encapsulator (const std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
+      fun_encapsulator (const std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
         : function (function)
       {}
 
       inline
       Thread<RT>
-      operator() (typename std_cxx1x::tuple_element<0,ArgList>::type arg1,
-                  typename std_cxx1x::tuple_element<1,ArgList>::type arg2,
-                  typename std_cxx1x::tuple_element<2,ArgList>::type arg3,
-                  typename std_cxx1x::tuple_element<3,ArgList>::type arg4)
+      operator() (typename std_cxx11::tuple_element<0,ArgList>::type arg1,
+                  typename std_cxx11::tuple_element<1,ArgList>::type arg2,
+                  typename std_cxx11::tuple_element<2,ArgList>::type arg3,
+                  typename std_cxx11::tuple_element<3,ArgList>::type arg4)
       {
         return
           Thread<RT>
-          (std_cxx1x::bind (function,
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<0,ArgList>::type>::act(arg1),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<1,ArgList>::type>::act(arg2),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<2,ArgList>::type>::act(arg3),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<3,ArgList>::type>::act(arg4)));
+          (std_cxx11::bind (function,
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<0,ArgList>::type>::act(arg1),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<1,ArgList>::type>::act(arg2),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<2,ArgList>::type>::act(arg3),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<3,ArgList>::type>::act(arg4)));
       }
 
     private:
-      std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> function;
+      std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> function;
     };
 
     /**
@@ -1897,30 +1897,30 @@ namespace Threads
         : function (*function)
       {}
 
-      fun_encapsulator (const std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
+      fun_encapsulator (const std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
         : function (function)
       {}
 
       inline
       Thread<RT>
-      operator() (typename std_cxx1x::tuple_element<0,ArgList>::type arg1,
-                  typename std_cxx1x::tuple_element<1,ArgList>::type arg2,
-                  typename std_cxx1x::tuple_element<2,ArgList>::type arg3,
-                  typename std_cxx1x::tuple_element<3,ArgList>::type arg4,
-                  typename std_cxx1x::tuple_element<4,ArgList>::type arg5)
+      operator() (typename std_cxx11::tuple_element<0,ArgList>::type arg1,
+                  typename std_cxx11::tuple_element<1,ArgList>::type arg2,
+                  typename std_cxx11::tuple_element<2,ArgList>::type arg3,
+                  typename std_cxx11::tuple_element<3,ArgList>::type arg4,
+                  typename std_cxx11::tuple_element<4,ArgList>::type arg5)
       {
         return
           Thread<RT>
-          (std_cxx1x::bind (function,
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<0,ArgList>::type>::act(arg1),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<1,ArgList>::type>::act(arg2),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<2,ArgList>::type>::act(arg3),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<3,ArgList>::type>::act(arg4),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<4,ArgList>::type>::act(arg5)));
+          (std_cxx11::bind (function,
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<0,ArgList>::type>::act(arg1),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<1,ArgList>::type>::act(arg2),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<2,ArgList>::type>::act(arg3),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<3,ArgList>::type>::act(arg4),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<4,ArgList>::type>::act(arg5)));
       }
 
     private:
-      std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> function;
+      std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> function;
     };
 
     /**
@@ -1936,32 +1936,32 @@ namespace Threads
         : function (*function)
       {}
 
-      fun_encapsulator (const std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
+      fun_encapsulator (const std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
         : function (function)
       {}
 
       inline
       Thread<RT>
-      operator() (typename std_cxx1x::tuple_element<0,ArgList>::type arg1,
-                  typename std_cxx1x::tuple_element<1,ArgList>::type arg2,
-                  typename std_cxx1x::tuple_element<2,ArgList>::type arg3,
-                  typename std_cxx1x::tuple_element<3,ArgList>::type arg4,
-                  typename std_cxx1x::tuple_element<4,ArgList>::type arg5,
-                  typename std_cxx1x::tuple_element<5,ArgList>::type arg6)
+      operator() (typename std_cxx11::tuple_element<0,ArgList>::type arg1,
+                  typename std_cxx11::tuple_element<1,ArgList>::type arg2,
+                  typename std_cxx11::tuple_element<2,ArgList>::type arg3,
+                  typename std_cxx11::tuple_element<3,ArgList>::type arg4,
+                  typename std_cxx11::tuple_element<4,ArgList>::type arg5,
+                  typename std_cxx11::tuple_element<5,ArgList>::type arg6)
       {
         return
           Thread<RT>
-          (std_cxx1x::bind (function,
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<0,ArgList>::type>::act(arg1),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<1,ArgList>::type>::act(arg2),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<2,ArgList>::type>::act(arg3),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<3,ArgList>::type>::act(arg4),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<4,ArgList>::type>::act(arg5),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<5,ArgList>::type>::act(arg6)));
+          (std_cxx11::bind (function,
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<0,ArgList>::type>::act(arg1),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<1,ArgList>::type>::act(arg2),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<2,ArgList>::type>::act(arg3),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<3,ArgList>::type>::act(arg4),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<4,ArgList>::type>::act(arg5),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<5,ArgList>::type>::act(arg6)));
       }
 
     private:
-      std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> function;
+      std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> function;
     };
 
     /**
@@ -1977,34 +1977,34 @@ namespace Threads
         : function (*function)
       {}
 
-      fun_encapsulator (const std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
+      fun_encapsulator (const std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
         : function (function)
       {}
 
       inline
       Thread<RT>
-      operator() (typename std_cxx1x::tuple_element<0,ArgList>::type arg1,
-                  typename std_cxx1x::tuple_element<1,ArgList>::type arg2,
-                  typename std_cxx1x::tuple_element<2,ArgList>::type arg3,
-                  typename std_cxx1x::tuple_element<3,ArgList>::type arg4,
-                  typename std_cxx1x::tuple_element<4,ArgList>::type arg5,
-                  typename std_cxx1x::tuple_element<5,ArgList>::type arg6,
-                  typename std_cxx1x::tuple_element<6,ArgList>::type arg7)
+      operator() (typename std_cxx11::tuple_element<0,ArgList>::type arg1,
+                  typename std_cxx11::tuple_element<1,ArgList>::type arg2,
+                  typename std_cxx11::tuple_element<2,ArgList>::type arg3,
+                  typename std_cxx11::tuple_element<3,ArgList>::type arg4,
+                  typename std_cxx11::tuple_element<4,ArgList>::type arg5,
+                  typename std_cxx11::tuple_element<5,ArgList>::type arg6,
+                  typename std_cxx11::tuple_element<6,ArgList>::type arg7)
       {
         return
           Thread<RT>
-          (std_cxx1x::bind (function,
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<0,ArgList>::type>::act(arg1),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<1,ArgList>::type>::act(arg2),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<2,ArgList>::type>::act(arg3),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<3,ArgList>::type>::act(arg4),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<4,ArgList>::type>::act(arg5),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<5,ArgList>::type>::act(arg6),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<6,ArgList>::type>::act(arg7)));
+          (std_cxx11::bind (function,
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<0,ArgList>::type>::act(arg1),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<1,ArgList>::type>::act(arg2),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<2,ArgList>::type>::act(arg3),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<3,ArgList>::type>::act(arg4),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<4,ArgList>::type>::act(arg5),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<5,ArgList>::type>::act(arg6),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<6,ArgList>::type>::act(arg7)));
       }
 
     private:
-      std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> function;
+      std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> function;
     };
 
     /**
@@ -2020,36 +2020,36 @@ namespace Threads
         : function (*function)
       {}
 
-      fun_encapsulator (const std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
+      fun_encapsulator (const std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
         : function (function)
       {}
 
       inline
       Thread<RT>
-      operator() (typename std_cxx1x::tuple_element<0,ArgList>::type arg1,
-                  typename std_cxx1x::tuple_element<1,ArgList>::type arg2,
-                  typename std_cxx1x::tuple_element<2,ArgList>::type arg3,
-                  typename std_cxx1x::tuple_element<3,ArgList>::type arg4,
-                  typename std_cxx1x::tuple_element<4,ArgList>::type arg5,
-                  typename std_cxx1x::tuple_element<5,ArgList>::type arg6,
-                  typename std_cxx1x::tuple_element<6,ArgList>::type arg7,
-                  typename std_cxx1x::tuple_element<7,ArgList>::type arg8)
+      operator() (typename std_cxx11::tuple_element<0,ArgList>::type arg1,
+                  typename std_cxx11::tuple_element<1,ArgList>::type arg2,
+                  typename std_cxx11::tuple_element<2,ArgList>::type arg3,
+                  typename std_cxx11::tuple_element<3,ArgList>::type arg4,
+                  typename std_cxx11::tuple_element<4,ArgList>::type arg5,
+                  typename std_cxx11::tuple_element<5,ArgList>::type arg6,
+                  typename std_cxx11::tuple_element<6,ArgList>::type arg7,
+                  typename std_cxx11::tuple_element<7,ArgList>::type arg8)
       {
         return
           Thread<RT>
-          (std_cxx1x::bind (function,
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<0,ArgList>::type>::act(arg1),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<1,ArgList>::type>::act(arg2),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<2,ArgList>::type>::act(arg3),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<3,ArgList>::type>::act(arg4),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<4,ArgList>::type>::act(arg5),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<5,ArgList>::type>::act(arg6),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<6,ArgList>::type>::act(arg7),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<7,ArgList>::type>::act(arg8)));
+          (std_cxx11::bind (function,
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<0,ArgList>::type>::act(arg1),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<1,ArgList>::type>::act(arg2),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<2,ArgList>::type>::act(arg3),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<3,ArgList>::type>::act(arg4),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<4,ArgList>::type>::act(arg5),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<5,ArgList>::type>::act(arg6),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<6,ArgList>::type>::act(arg7),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<7,ArgList>::type>::act(arg8)));
       }
 
     private:
-      std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> function;
+      std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> function;
     };
 
     /**
@@ -2065,38 +2065,38 @@ namespace Threads
         : function (*function)
       {}
 
-      fun_encapsulator (const std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
+      fun_encapsulator (const std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> &function)
         : function (function)
       {}
 
       inline
       Thread<RT>
-      operator() (typename std_cxx1x::tuple_element<0,ArgList>::type arg1,
-                  typename std_cxx1x::tuple_element<1,ArgList>::type arg2,
-                  typename std_cxx1x::tuple_element<2,ArgList>::type arg3,
-                  typename std_cxx1x::tuple_element<3,ArgList>::type arg4,
-                  typename std_cxx1x::tuple_element<4,ArgList>::type arg5,
-                  typename std_cxx1x::tuple_element<5,ArgList>::type arg6,
-                  typename std_cxx1x::tuple_element<6,ArgList>::type arg7,
-                  typename std_cxx1x::tuple_element<7,ArgList>::type arg8,
-                  typename std_cxx1x::tuple_element<8,ArgList>::type arg9)
+      operator() (typename std_cxx11::tuple_element<0,ArgList>::type arg1,
+                  typename std_cxx11::tuple_element<1,ArgList>::type arg2,
+                  typename std_cxx11::tuple_element<2,ArgList>::type arg3,
+                  typename std_cxx11::tuple_element<3,ArgList>::type arg4,
+                  typename std_cxx11::tuple_element<4,ArgList>::type arg5,
+                  typename std_cxx11::tuple_element<5,ArgList>::type arg6,
+                  typename std_cxx11::tuple_element<6,ArgList>::type arg7,
+                  typename std_cxx11::tuple_element<7,ArgList>::type arg8,
+                  typename std_cxx11::tuple_element<8,ArgList>::type arg9)
       {
         return
           Thread<RT>
-          (std_cxx1x::bind (function,
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<0,ArgList>::type>::act(arg1),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<1,ArgList>::type>::act(arg2),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<2,ArgList>::type>::act(arg3),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<3,ArgList>::type>::act(arg4),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<4,ArgList>::type>::act(arg5),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<5,ArgList>::type>::act(arg6),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<6,ArgList>::type>::act(arg7),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<7,ArgList>::type>::act(arg8),
-                            internal::maybe_make_ref<typename std_cxx1x::tuple_element<8,ArgList>::type>::act(arg9)));
+          (std_cxx11::bind (function,
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<0,ArgList>::type>::act(arg1),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<1,ArgList>::type>::act(arg2),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<2,ArgList>::type>::act(arg3),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<3,ArgList>::type>::act(arg4),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<4,ArgList>::type>::act(arg5),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<5,ArgList>::type>::act(arg6),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<6,ArgList>::type>::act(arg7),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<7,ArgList>::type>::act(arg8),
+                            internal::maybe_make_ref<typename std_cxx11::tuple_element<8,ArgList>::type>::act(arg9)));
       }
 
     private:
-      std_cxx1x::function<typename internal::fun_ptr<RT,ArgList>::type> function;
+      std_cxx11::function<typename internal::fun_ptr<RT,ArgList>::type> function;
     };
   }
 
@@ -2114,13 +2114,13 @@ namespace Threads
    */
   template <typename RT>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<>,0>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<>,0>
   spawn (RT (*fun_ptr)()) DEAL_II_DEPRECATED;
 
 
   template <typename RT>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<>,0>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<>,0>
   spawn (RT (*fun_ptr)())
   {
     return fun_ptr;
@@ -2136,18 +2136,18 @@ namespace Threads
    */
   template <typename RT, typename C>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<>,0>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<>,0>
   spawn (C &c, RT (C::*fun_ptr)()) DEAL_II_DEPRECATED;
 
 
   template <typename RT, typename C>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<>,0>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<>,0>
   spawn (C &c, RT (C::*fun_ptr)())
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c)));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c)));
   }
 
   /**
@@ -2159,18 +2159,18 @@ namespace Threads
    */
   template <typename RT, typename C>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<>,0>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<>,0>
   spawn (const C &c, RT (C::*fun_ptr)() const) DEAL_II_DEPRECATED;
 
 
   template <typename RT, typename C>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<>,0>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<>,0>
   spawn (const C &c, RT (C::*fun_ptr)() const)
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c)));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c)));
   }
 
 
@@ -2187,13 +2187,13 @@ namespace Threads
    */
   template <typename RT, typename Arg1>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1>,1>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1>,1>
   spawn (RT (*fun_ptr)(Arg1)) DEAL_II_DEPRECATED;
 
 
   template <typename RT, typename Arg1>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1>,1>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1>,1>
   spawn (RT (*fun_ptr)(Arg1))
   {
     return fun_ptr;
@@ -2210,18 +2210,18 @@ namespace Threads
    */
   template <typename RT, typename C, typename Arg1>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1>,1>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1>,1>
   spawn (C &c, RT (C::*fun_ptr)(Arg1)) DEAL_II_DEPRECATED;
 
 
   template <typename RT, typename C, typename Arg1>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1>,1>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1>,1>
   spawn (C &c, RT (C::*fun_ptr)(Arg1))
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<Arg1> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), std_cxx1x::_1));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<Arg1> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), std_cxx11::_1));
   }
 
   /**
@@ -2233,18 +2233,18 @@ namespace Threads
    */
   template <typename RT, typename C, typename Arg1>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1>,1>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1>,1>
   spawn (const C &c, RT (C::*fun_ptr)(Arg1) const) DEAL_II_DEPRECATED;
 
 
   template <typename RT, typename C, typename Arg1>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1>,1>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1>,1>
   spawn (const C &c, RT (C::*fun_ptr)(Arg1) const)
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<Arg1> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), std_cxx1x::_1));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<Arg1> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), std_cxx11::_1));
   }
 
 
@@ -2259,13 +2259,13 @@ namespace Threads
    */
   template <typename RT, typename Arg1, typename Arg2>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2>,2>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2>,2>
   spawn (RT (*fun_ptr)(Arg1,Arg2)) DEAL_II_DEPRECATED;
 
 
   template <typename RT, typename Arg1, typename Arg2>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2>,2>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2>,2>
   spawn (RT (*fun_ptr)(Arg1,Arg2))
   {
     return fun_ptr;
@@ -2282,18 +2282,18 @@ namespace Threads
    */
   template <typename RT, typename C, typename Arg1, typename Arg2>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2>,2>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2>,2>
   spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2)) DEAL_II_DEPRECATED;
 
 
   template <typename RT, typename C, typename Arg1, typename Arg2>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2>,2>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2>,2>
   spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2))
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<Arg1,Arg2> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), std_cxx1x::_1, std_cxx1x::_2));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<Arg1,Arg2> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), std_cxx11::_1, std_cxx11::_2));
   }
 
   /**
@@ -2305,18 +2305,18 @@ namespace Threads
    */
   template <typename RT, typename C, typename Arg1, typename Arg2>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2>,2>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2>,2>
   spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2) const) DEAL_II_DEPRECATED;
 
 
   template <typename RT, typename C, typename Arg1, typename Arg2>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2>,2>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2>,2>
   spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2) const)
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<Arg1,Arg2> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), std_cxx1x::_1, std_cxx1x::_2));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<Arg1,Arg2> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), std_cxx11::_1, std_cxx11::_2));
   }
 
 
@@ -2332,14 +2332,14 @@ namespace Threads
   template <typename RT,
             typename Arg1, typename Arg2, typename Arg3>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3>,3>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3>,3>
   spawn (RT (*fun_ptr)(Arg1,Arg2,Arg3)) DEAL_II_DEPRECATED;
 
 
   template <typename RT,
             typename Arg1, typename Arg2, typename Arg3>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3>,3>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3>,3>
   spawn (RT (*fun_ptr)(Arg1,Arg2,Arg3))
   {
     return fun_ptr;
@@ -2357,19 +2357,19 @@ namespace Threads
   template <typename RT, typename C,
             typename Arg1, typename Arg2, typename Arg3>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3>,3>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3>,3>
   spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3)) DEAL_II_DEPRECATED;
 
 
   template <typename RT, typename C,
             typename Arg1, typename Arg2, typename Arg3>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3>,3>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3>,3>
   spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3))
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<Arg1,Arg2,Arg3> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<Arg1,Arg2,Arg3> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), std_cxx11::_1, std_cxx11::_2, std_cxx11::_3));
   }
 
   /**
@@ -2382,19 +2382,19 @@ namespace Threads
   template <typename RT, typename C,
             typename Arg1, typename Arg2, typename Arg3>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3>,3>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3>,3>
   spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3) const) DEAL_II_DEPRECATED;
 
 
   template <typename RT, typename C,
             typename Arg1, typename Arg2, typename Arg3>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3>,3>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3>,3>
   spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3) const)
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<Arg1,Arg2,Arg3> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<Arg1,Arg2,Arg3> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), std_cxx11::_1, std_cxx11::_2, std_cxx11::_3));
   }
 
 
@@ -2411,14 +2411,14 @@ namespace Threads
   template <typename RT,
             typename Arg1, typename Arg2, typename Arg3, typename Arg4>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4>,4>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4>,4>
   spawn (RT (*fun_ptr)(Arg1,Arg2,Arg3,Arg4)) DEAL_II_DEPRECATED;
 
 
   template <typename RT,
             typename Arg1, typename Arg2, typename Arg3, typename Arg4>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4>,4>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4>,4>
   spawn (RT (*fun_ptr)(Arg1,Arg2,Arg3,Arg4))
   {
     return fun_ptr;
@@ -2436,19 +2436,19 @@ namespace Threads
   template <typename RT, typename C,
             typename Arg1, typename Arg2, typename Arg3, typename Arg4>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4>,4>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4>,4>
   spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4)) DEAL_II_DEPRECATED;
 
 
   template <typename RT, typename C,
             typename Arg1, typename Arg2, typename Arg3, typename Arg4>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4>,4>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4>,4>
   spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4))
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::_4));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), std_cxx11::_1, std_cxx11::_2, std_cxx11::_3, std_cxx11::_4));
   }
 
   /**
@@ -2461,19 +2461,19 @@ namespace Threads
   template <typename RT, typename C,
             typename Arg1, typename Arg2, typename Arg3, typename Arg4>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4>,4>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4>,4>
   spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4) const) DEAL_II_DEPRECATED;
 
 
   template <typename RT, typename C,
             typename Arg1, typename Arg2, typename Arg3, typename Arg4>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4>,4>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4>,4>
   spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4) const)
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::_4));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), std_cxx11::_1, std_cxx11::_2, std_cxx11::_3, std_cxx11::_4));
   }
 
 
@@ -2490,7 +2490,7 @@ namespace Threads
             typename Arg1, typename Arg2, typename Arg3,
             typename Arg4, typename Arg5>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5>,5>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5>,5>
   spawn (RT (*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5)) DEAL_II_DEPRECATED;
 
 
@@ -2498,7 +2498,7 @@ namespace Threads
             typename Arg1, typename Arg2, typename Arg3,
             typename Arg4, typename Arg5>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5>,5>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5>,5>
   spawn (RT (*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5))
   {
     return fun_ptr;
@@ -2517,7 +2517,7 @@ namespace Threads
             typename Arg1, typename Arg2, typename Arg3,
             typename Arg4, typename Arg5>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5>,5>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5>,5>
   spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5)) DEAL_II_DEPRECATED;
 
 
@@ -2525,12 +2525,12 @@ namespace Threads
             typename Arg1, typename Arg2, typename Arg3,
             typename Arg4, typename Arg5>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5>,5>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5>,5>
   spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5))
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::_4, std_cxx1x::_5));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), std_cxx11::_1, std_cxx11::_2, std_cxx11::_3, std_cxx11::_4, std_cxx11::_5));
   }
 
   /**
@@ -2544,7 +2544,7 @@ namespace Threads
             typename Arg1, typename Arg2, typename Arg3,
             typename Arg4, typename Arg5>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5>,5>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5>,5>
   spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5) const) DEAL_II_DEPRECATED;
 
 
@@ -2552,12 +2552,12 @@ namespace Threads
             typename Arg1, typename Arg2, typename Arg3,
             typename Arg4, typename Arg5>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5>,5>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5>,5>
   spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5) const)
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::_4, std_cxx1x::_5));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), std_cxx11::_1, std_cxx11::_2, std_cxx11::_3, std_cxx11::_4, std_cxx11::_5));
   }
 
 
@@ -2574,7 +2574,7 @@ namespace Threads
             typename Arg1, typename Arg2, typename Arg3,
             typename Arg4, typename Arg5, typename Arg6>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6>,6>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6>,6>
   spawn (RT (*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,Arg6)) DEAL_II_DEPRECATED;
 
 
@@ -2582,7 +2582,7 @@ namespace Threads
             typename Arg1, typename Arg2, typename Arg3,
             typename Arg4, typename Arg5, typename Arg6>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6>,6>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6>,6>
   spawn (RT (*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,Arg6))
   {
     return fun_ptr;
@@ -2601,7 +2601,7 @@ namespace Threads
             typename Arg1, typename Arg2, typename Arg3,
             typename Arg4, typename Arg5, typename Arg6>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6>,6>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6>,6>
   spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,Arg6)) DEAL_II_DEPRECATED;
 
 
@@ -2609,12 +2609,12 @@ namespace Threads
             typename Arg1, typename Arg2, typename Arg3,
             typename Arg4, typename Arg5, typename Arg6>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6>,6>
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6>,6>
   spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,Arg6))
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::_4, std_cxx1x::_5, std_cxx1x::_6));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), std_cxx11::_1, std_cxx11::_2, std_cxx11::_3, std_cxx11::_4, std_cxx11::_5, std_cxx11::_6));
   }
 
   /**
@@ -2629,7 +2629,7 @@ namespace Threads
             typename Arg4, typename Arg5, typename Arg6>
   inline
   internal::fun_encapsulator<RT,
-           std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6>,6>
+           std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6>,6>
            spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,Arg6) const) DEAL_II_DEPRECATED;
 
 
@@ -2638,12 +2638,12 @@ namespace Threads
             typename Arg4, typename Arg5, typename Arg6>
   inline
   internal::fun_encapsulator<RT,
-           std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6>,6>
+           std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6>,6>
            spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,Arg6) const)
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::_4, std_cxx1x::_5, std_cxx1x::_6));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), std_cxx11::_1, std_cxx11::_2, std_cxx11::_3, std_cxx11::_4, std_cxx11::_5, std_cxx11::_6));
   }
 
 
@@ -2661,7 +2661,7 @@ namespace Threads
             typename Arg4, typename Arg5, typename Arg6,
             typename Arg7>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3,
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3,
            Arg4, Arg5, Arg6, Arg7>,7>
            spawn (RT (*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,Arg6,Arg7)) DEAL_II_DEPRECATED;
 
@@ -2671,7 +2671,7 @@ namespace Threads
             typename Arg4, typename Arg5, typename Arg6,
             typename Arg7>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3,
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3,
            Arg4, Arg5, Arg6, Arg7>,7>
            spawn (RT (*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,Arg6,Arg7))
   {
@@ -2692,7 +2692,7 @@ namespace Threads
             typename Arg4, typename Arg5, typename Arg6,
             typename Arg7>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3,
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3,
            Arg4, Arg5, Arg6, Arg7>,7>
            spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,Arg6,Arg7)) DEAL_II_DEPRECATED;
 
@@ -2702,13 +2702,13 @@ namespace Threads
             typename Arg4, typename Arg5, typename Arg6,
             typename Arg7>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3,
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3,
            Arg4, Arg5, Arg6, Arg7>,7>
            spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,Arg6,Arg7))
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::_4, std_cxx1x::_5, std_cxx1x::_6, std_cxx1x::_7));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), std_cxx11::_1, std_cxx11::_2, std_cxx11::_3, std_cxx11::_4, std_cxx11::_5, std_cxx11::_6, std_cxx11::_7));
   }
 
   /**
@@ -2724,7 +2724,7 @@ namespace Threads
             typename Arg7>
   inline
   internal::fun_encapsulator<RT,
-           std_cxx1x::tuple<Arg1, Arg2, Arg3,
+           std_cxx11::tuple<Arg1, Arg2, Arg3,
            Arg4, Arg5, Arg6, Arg7>,7>
            spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,Arg6,Arg7) const) DEAL_II_DEPRECATED;
 
@@ -2735,13 +2735,13 @@ namespace Threads
             typename Arg7>
   inline
   internal::fun_encapsulator<RT,
-           std_cxx1x::tuple<Arg1, Arg2, Arg3,
+           std_cxx11::tuple<Arg1, Arg2, Arg3,
            Arg4, Arg5, Arg6, Arg7>,7>
            spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,Arg6,Arg7) const)
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::_4, std_cxx1x::_5, std_cxx1x::_6, std_cxx1x::_7));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), std_cxx11::_1, std_cxx11::_2, std_cxx11::_3, std_cxx11::_4, std_cxx11::_5, std_cxx11::_6, std_cxx11::_7));
   }
 
 
@@ -2759,7 +2759,7 @@ namespace Threads
             typename Arg4, typename Arg5, typename Arg6,
             typename Arg7, typename Arg8>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3,
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3,
            Arg4, Arg5, Arg6,
            Arg7, Arg8>,8>
            spawn (RT (*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,
@@ -2771,7 +2771,7 @@ namespace Threads
             typename Arg4, typename Arg5, typename Arg6,
             typename Arg7, typename Arg8>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3,
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3,
            Arg4, Arg5, Arg6,
            Arg7, Arg8>,8>
            spawn (RT (*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,
@@ -2794,7 +2794,7 @@ namespace Threads
             typename Arg4, typename Arg5, typename Arg6,
             typename Arg7, typename Arg8>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3,
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3,
            Arg4, Arg5, Arg6,
            Arg7, Arg8>,8>
            spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,
@@ -2806,15 +2806,15 @@ namespace Threads
             typename Arg4, typename Arg5, typename Arg6,
             typename Arg7, typename Arg8>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3,
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3,
            Arg4, Arg5, Arg6,
            Arg7, Arg8>,8>
            spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,
                                          Arg6,Arg7,Arg8))
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7, Arg8> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::_4, std_cxx1x::_5, std_cxx1x::_6, std_cxx1x::_7, std_cxx1x::_8));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7, Arg8> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), std_cxx11::_1, std_cxx11::_2, std_cxx11::_3, std_cxx11::_4, std_cxx11::_5, std_cxx11::_6, std_cxx11::_7, std_cxx11::_8));
   }
 
   /**
@@ -2830,7 +2830,7 @@ namespace Threads
             typename Arg7, typename Arg8>
   inline
   internal::fun_encapsulator<RT,
-           std_cxx1x::tuple<Arg1, Arg2, Arg3,
+           std_cxx11::tuple<Arg1, Arg2, Arg3,
            Arg4, Arg5, Arg6,
            Arg7, Arg8>,8>
            spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,
@@ -2843,15 +2843,15 @@ namespace Threads
             typename Arg7, typename Arg8>
   inline
   internal::fun_encapsulator<RT,
-           std_cxx1x::tuple<Arg1, Arg2, Arg3,
+           std_cxx11::tuple<Arg1, Arg2, Arg3,
            Arg4, Arg5, Arg6,
            Arg7, Arg8>,8>
            spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,
                                                Arg6,Arg7,Arg8) const)
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7, Arg8> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::_4, std_cxx1x::_5, std_cxx1x::_6, std_cxx1x::_7, std_cxx1x::_8));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7, Arg8> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), std_cxx11::_1, std_cxx11::_2, std_cxx11::_3, std_cxx11::_4, std_cxx11::_5, std_cxx11::_6, std_cxx11::_7, std_cxx11::_8));
   }
 
 
@@ -2869,7 +2869,7 @@ namespace Threads
             typename Arg4, typename Arg5, typename Arg6,
             typename Arg7, typename Arg8, typename Arg9>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3,
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3,
            Arg4, Arg5, Arg6,
            Arg7, Arg8, Arg9>,9>
            spawn (RT (*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,
@@ -2881,7 +2881,7 @@ namespace Threads
             typename Arg4, typename Arg5, typename Arg6,
             typename Arg7, typename Arg8, typename Arg9>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3,
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3,
            Arg4, Arg5, Arg6,
            Arg7, Arg8, Arg9>,9>
            spawn (RT (*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,
@@ -2904,7 +2904,7 @@ namespace Threads
             typename Arg4, typename Arg5, typename Arg6,
             typename Arg7, typename Arg8, typename Arg9>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3,
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3,
            Arg4, Arg5, Arg6,
            Arg7, Arg8, Arg9>,9>
            spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,
@@ -2916,15 +2916,15 @@ namespace Threads
             typename Arg4, typename Arg5, typename Arg6,
             typename Arg7, typename Arg8, typename Arg9>
   inline
-  internal::fun_encapsulator<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3,
+  internal::fun_encapsulator<RT,std_cxx11::tuple<Arg1, Arg2, Arg3,
            Arg4, Arg5, Arg6,
            Arg7, Arg8, Arg9>,9>
            spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,
                                          Arg6,Arg7,Arg8,Arg9))
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7, Arg8, Arg9> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::_4, std_cxx1x::_5, std_cxx1x::_6, std_cxx1x::_7, std_cxx1x::_8, std_cxx1x::_9));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7, Arg8, Arg9> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), std_cxx11::_1, std_cxx11::_2, std_cxx11::_3, std_cxx11::_4, std_cxx11::_5, std_cxx11::_6, std_cxx11::_7, std_cxx11::_8, std_cxx11::_9));
   }
 
   /**
@@ -2940,7 +2940,7 @@ namespace Threads
             typename Arg7, typename Arg8, typename Arg9>
   inline
   internal::fun_encapsulator<RT,
-           std_cxx1x::tuple<Arg1, Arg2, Arg3,
+           std_cxx11::tuple<Arg1, Arg2, Arg3,
            Arg4, Arg5, Arg6,
            Arg7, Arg8, Arg9>,9>
            spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,
@@ -2953,15 +2953,15 @@ namespace Threads
             typename Arg7, typename Arg8, typename Arg9>
   inline
   internal::fun_encapsulator<RT,
-           std_cxx1x::tuple<Arg1, Arg2, Arg3,
+           std_cxx11::tuple<Arg1, Arg2, Arg3,
            Arg4, Arg5, Arg6,
            Arg7, Arg8, Arg9>,9>
            spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,
                                                Arg6,Arg7,Arg8,Arg9) const)
   {
     return
-      std_cxx1x::function<typename internal::fun_ptr<RT,std_cxx1x::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7, Arg8, Arg9> >::type>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::_4, std_cxx1x::_5, std_cxx1x::_6, std_cxx1x::_7, std_cxx1x::_8, std_cxx1x::_9));
+      std_cxx11::function<typename internal::fun_ptr<RT,std_cxx11::tuple<Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7, Arg8, Arg9> >::type>
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), std_cxx11::_1, std_cxx11::_2, std_cxx11::_3, std_cxx11::_4, std_cxx11::_5, std_cxx11::_6, std_cxx11::_7, std_cxx11::_8, std_cxx11::_9));
   }
 
 
@@ -2971,7 +2971,7 @@ namespace Threads
   /**
    * Overload of the new_thread function for
    * objects that can be converted to
-   * std_cxx1x::function<RT ()>, i.e. anything
+   * std_cxx11::function<RT ()>, i.e. anything
    * that can be called like a function
    * object without arguments and returning
    * an object of type RT (or void).
@@ -2981,7 +2981,7 @@ namespace Threads
   template <typename RT>
   inline
   Thread<RT>
-  new_thread (const std_cxx1x::function<RT ()> &function)
+  new_thread (const std_cxx11::function<RT ()> &function)
   {
     return Thread<RT>(function);
   }
@@ -3017,7 +3017,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c)));
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c)));
   }
 
 
@@ -3037,7 +3037,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c)));
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c)));
   }
 #endif
 
@@ -3060,7 +3060,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr,
+      (std_cxx11::bind(fun_ptr,
                        internal::maybe_make_ref<Arg1>::act(arg1)));
   }
 
@@ -3082,7 +3082,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1)));
   }
 
@@ -3103,7 +3103,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1)));
   }
 #endif
@@ -3126,7 +3126,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr,
+      (std_cxx11::bind(fun_ptr,
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2)));
   }
@@ -3150,7 +3150,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2)));
   }
@@ -3173,7 +3173,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2)));
   }
@@ -3199,7 +3199,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr,
+      (std_cxx11::bind(fun_ptr,
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3)));
@@ -3226,7 +3226,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3)));
@@ -3252,7 +3252,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3)));
@@ -3281,7 +3281,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr,
+      (std_cxx11::bind(fun_ptr,
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -3310,7 +3310,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -3338,7 +3338,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -3369,7 +3369,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr,
+      (std_cxx11::bind(fun_ptr,
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -3401,7 +3401,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -3432,7 +3432,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -3465,7 +3465,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr,
+      (std_cxx11::bind(fun_ptr,
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -3499,7 +3499,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -3532,7 +3532,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -3568,7 +3568,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr,
+      (std_cxx11::bind(fun_ptr,
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -3605,7 +3605,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -3641,7 +3641,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -3680,7 +3680,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr,
+      (std_cxx11::bind(fun_ptr,
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -3720,7 +3720,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -3759,7 +3759,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -3800,7 +3800,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr,
+      (std_cxx11::bind(fun_ptr,
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -3842,7 +3842,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -3883,7 +3883,7 @@ namespace Threads
   {
     return
       Thread<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -4047,7 +4047,7 @@ namespace Threads
        * The function and its arguments
        * that are to be run on the task.
        */
-      std_cxx1x::function<RT ()> function;
+      std_cxx11::function<RT ()> function;
 
       /**
        * Variable holding the data the TBB
@@ -4082,7 +4082,7 @@ namespace Threads
        * Constructor. Take the function to
        * be run on this task as argument.
        */
-      TaskDescriptor (const std_cxx1x::function<RT ()> &function);
+      TaskDescriptor (const std_cxx11::function<RT ()> &function);
 
       /**
        * Default
@@ -4147,7 +4147,7 @@ namespace Threads
 
     template <typename RT>
     inline
-    TaskDescriptor<RT>::TaskDescriptor (const std_cxx1x::function<RT ()> &function)
+    TaskDescriptor<RT>::TaskDescriptor (const std_cxx11::function<RT ()> &function)
       :
       function (function),
       task_is_done (false)
@@ -4274,7 +4274,7 @@ namespace Threads
        * slot reserved for this
        * purpose.
        */
-      TaskDescriptor (const std_cxx1x::function<RT ()> &function)
+      TaskDescriptor (const std_cxx11::function<RT ()> &function)
       {
         call (function, ret_val);
       }
@@ -4325,13 +4325,13 @@ namespace Threads
      * given a function object to
      * execute on the task.
      */
-    Task (const std_cxx1x::function<RT ()> &function_object)
+    Task (const std_cxx11::function<RT ()> &function_object)
     {
       // create a task descriptor and tell it
       // to queue itself up with the scheduling
       // system
       task_descriptor =
-        std_cxx1x::shared_ptr<internal::TaskDescriptor<RT> >
+        std_cxx11::shared_ptr<internal::TaskDescriptor<RT> >
         (new internal::TaskDescriptor<RT>(function_object));
       task_descriptor->queue_task ();
     }
@@ -4370,7 +4370,7 @@ namespace Threads
     void join () const
     {
       AssertThrow (task_descriptor !=
-                   std_cxx1x::shared_ptr<internal::TaskDescriptor<RT> >(),
+                   std_cxx11::shared_ptr<internal::TaskDescriptor<RT> >(),
                    ExcNoTask());
       task_descriptor->join ();
     }
@@ -4402,7 +4402,7 @@ namespace Threads
     bool operator == (const Task &t)
     {
       AssertThrow (task_descriptor !=
-                   std_cxx1x::shared_ptr<internal::TaskDescriptor<RT> >(),
+                   std_cxx11::shared_ptr<internal::TaskDescriptor<RT> >(),
                    ExcNoTask());
       return task_descriptor == t.task_descriptor;
     }
@@ -4424,7 +4424,7 @@ namespace Threads
      * long as there is at least one
      * subscriber to it.
      */
-    std_cxx1x::shared_ptr<internal::TaskDescriptor<RT> > task_descriptor;
+    std_cxx11::shared_ptr<internal::TaskDescriptor<RT> > task_descriptor;
   };
 
 
@@ -4432,7 +4432,7 @@ namespace Threads
   /**
    * Overload of the new_task function for
    * objects that can be converted to
-   * std_cxx1x::function<RT ()>, i.e. anything
+   * std_cxx11::function<RT ()>, i.e. anything
    * that can be called like a function
    * object without arguments and returning
    * an object of type RT (or void).
@@ -4442,7 +4442,7 @@ namespace Threads
   template <typename RT>
   inline
   Task<RT>
-  new_task (const std_cxx1x::function<RT ()> &function)
+  new_task (const std_cxx11::function<RT ()> &function)
   {
     return Task<RT>(function);
   }
@@ -4459,7 +4459,7 @@ namespace Threads
   Task<RT>
   new_task (RT (*fun_ptr)())
   {
-    return new_task<RT>(std_cxx1x::function<RT ()>(fun_ptr));
+    return new_task<RT>(std_cxx11::function<RT ()>(fun_ptr));
   }
 
 
@@ -4478,7 +4478,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c)));
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c)));
   }
 
 #ifndef DEAL_II_CONST_MEMBER_DEDUCTION_BUG
@@ -4497,7 +4497,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c)));
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c)));
   }
 #endif
 
@@ -4520,7 +4520,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr,
+      (std_cxx11::bind(fun_ptr,
                        internal::maybe_make_ref<Arg1>::act(arg1)));
   }
 
@@ -4542,7 +4542,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1)));
   }
 
@@ -4563,7 +4563,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1)));
   }
 #endif
@@ -4586,7 +4586,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr,
+      (std_cxx11::bind(fun_ptr,
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2)));
   }
@@ -4610,7 +4610,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2)));
   }
@@ -4633,7 +4633,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2)));
   }
@@ -4659,7 +4659,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr,
+      (std_cxx11::bind(fun_ptr,
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3)));
@@ -4686,7 +4686,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3)));
@@ -4712,7 +4712,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3)));
@@ -4741,7 +4741,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr,
+      (std_cxx11::bind(fun_ptr,
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -4770,7 +4770,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -4798,7 +4798,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -4829,7 +4829,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr,
+      (std_cxx11::bind(fun_ptr,
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -4861,7 +4861,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -4892,7 +4892,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -4925,7 +4925,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr,
+      (std_cxx11::bind(fun_ptr,
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -4959,7 +4959,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -4992,7 +4992,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -5028,7 +5028,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr,
+      (std_cxx11::bind(fun_ptr,
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -5065,7 +5065,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -5101,7 +5101,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -5140,7 +5140,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr,
+      (std_cxx11::bind(fun_ptr,
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -5180,7 +5180,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -5219,7 +5219,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -5260,7 +5260,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr,
+      (std_cxx11::bind(fun_ptr,
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -5302,7 +5302,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::ref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
@@ -5343,7 +5343,7 @@ namespace Threads
   {
     return
       new_task<RT>
-      (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c),
+      (std_cxx11::bind(fun_ptr, std_cxx11::cref(c),
                        internal::maybe_make_ref<Arg1>::act(arg1),
                        internal::maybe_make_ref<Arg2>::act(arg2),
                        internal::maybe_make_ref<Arg3>::act(arg3),
index 079b4605b354ff042b881e8588937d6267f72c92..3e130eb95fca4ab702dd69692f0a4df235a6bcdb 100644 (file)
@@ -19,7 +19,7 @@
 
 
 #include <deal.II/base/config.h>
-#include <deal.II/base/std_cxx1x/function.h>
+#include <deal.II/base/std_cxx11/function.h>
 
 #include <vector>
 
@@ -95,8 +95,8 @@ namespace TimeStepping
      * time step.
      */
     virtual double evolve_one_time_step(
-      std::vector<std_cxx1x::function<VECTOR (const double, const VECTOR &)> > &F,
-      std::vector<std_cxx1x::function<VECTOR (const double, const double, const VECTOR &)> > &J_inverse,
+      std::vector<std_cxx11::function<VECTOR (const double, const VECTOR &)> > &F,
+      std::vector<std_cxx11::function<VECTOR (const double, const double, const VECTOR &)> > &J_inverse,
       double t,
       double delta_t,
       VECTOR &y) = 0;
@@ -146,8 +146,8 @@ namespace TimeStepping
      * only contain one element.
      */
     double evolve_one_time_step(
-      std::vector<std_cxx1x::function<VECTOR (const double, const VECTOR &)> > &F,
-      std::vector<std_cxx1x::function<VECTOR (const double, const double, const VECTOR &)> > &J_inverse,
+      std::vector<std_cxx11::function<VECTOR (const double, const VECTOR &)> > &F,
+      std::vector<std_cxx11::function<VECTOR (const double, const double, const VECTOR &)> > &J_inverse,
       double t,
       double delta_t,
       VECTOR &y);
@@ -164,8 +164,8 @@ namespace TimeStepping
      * evolve_one_time_step returns the time at the end of the time step.
      */
     virtual double evolve_one_time_step(
-      std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
-      std_cxx1x::function<VECTOR (const double, const double, const VECTOR &)> id_minus_tau_J_inverse,
+      std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
+      std_cxx11::function<VECTOR (const double, const double, const VECTOR &)> id_minus_tau_J_inverse,
       double t,
       double delta_t,
       VECTOR &y) = 0;
@@ -231,8 +231,8 @@ namespace TimeStepping
      * evolve_one_time_step returns the time at the end of the time step.
      */
     double evolve_one_time_step(
-      std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
-      std_cxx1x::function<VECTOR (const double, const double, const VECTOR &)> id_minus_tau_J_inverse,
+      std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
+      std_cxx11::function<VECTOR (const double, const double, const VECTOR &)> id_minus_tau_J_inverse,
       double t,
       double delta_t,
       VECTOR &y);
@@ -244,7 +244,7 @@ namespace TimeStepping
      * explicit methods. evolve_one_time_step returns the time at the end of the
      * time step.
      */
-    double evolve_one_time_step(std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
+    double evolve_one_time_step(std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
                                 double t,
                                 double delta_t,
                                 VECTOR &y);
@@ -266,7 +266,7 @@ namespace TimeStepping
     /**
      * Compute the different stages needed.
      */
-    void compute_stages(std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
+    void compute_stages(std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
                         const double t,
                         const double delta_t,
                         const VECTOR &y,
@@ -322,8 +322,8 @@ namespace TimeStepping
      * evolve_one_time_step returns the time at the end of the time step.
      */
     double evolve_one_time_step(
-      std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
-      std_cxx1x::function<VECTOR (const double, const double, const VECTOR &)> id_minus_tau_J_inverse,
+      std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
+      std_cxx11::function<VECTOR (const double, const double, const VECTOR &)> id_minus_tau_J_inverse,
       double t,
       double delta_t,
       VECTOR &y);
@@ -356,8 +356,8 @@ namespace TimeStepping
      * Compute the different stages needed.
      */
     void compute_stages(
-      std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
-      std_cxx1x::function<VECTOR (const double, const double, const VECTOR &)> id_minus_tau_J_inverse,
+      std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
+      std_cxx11::function<VECTOR (const double, const double, const VECTOR &)> id_minus_tau_J_inverse,
       double t,
       double delta_t,
       VECTOR &y,
@@ -366,14 +366,14 @@ namespace TimeStepping
     /**
      * Newton solver used for the implicit stages.
      */
-    void newton_solve(std_cxx1x::function<void (const VECTOR &,VECTOR &)> get_residual,
-                      std_cxx1x::function<VECTOR (const VECTOR &)> id_minus_tau_J_inverse,
+    void newton_solve(std_cxx11::function<void (const VECTOR &,VECTOR &)> get_residual,
+                      std_cxx11::function<VECTOR (const VECTOR &)> id_minus_tau_J_inverse,
                       VECTOR &y);
 
     /**
      * Compute the residual needed by the Newton solver.
      */
-    void compute_residual(std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
+    void compute_residual(std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
                           double t,
                           double delta_t,
                           const VECTOR &old_y,
@@ -465,8 +465,8 @@ namespace TimeStepping
      * evolve_one_time_step returns the time at the end of the time step.
      */
     double evolve_one_time_step(
-      std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
-      std_cxx1x::function<VECTOR (const double, const double, const VECTOR &)> id_minus_tau_J_inverse,
+      std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
+      std_cxx11::function<VECTOR (const double, const double, const VECTOR &)> id_minus_tau_J_inverse,
       double t,
       double delta_t,
       VECTOR &y);
@@ -478,7 +478,7 @@ namespace TimeStepping
      * explicit methods. evolve_one_time_step returns the time at the end of the
      * time step.
      */
-    double evolve_one_time_step(std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
+    double evolve_one_time_step(std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
                                 double t,
                                 double delta_t,
                                 VECTOR &y);
@@ -517,7 +517,7 @@ namespace TimeStepping
     /**
      * Compute the different stages needed.
      */
-    void compute_stages(std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
+    void compute_stages(std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
                         const double t,
                         const double delta_t,
                         const VECTOR &y,
index a63e818b7a94010c710ac29fd0984632fdcc00c6..27261d7ebd5b99afc33be1d45664562d5197fc8a 100644 (file)
@@ -17,7 +17,7 @@
 #ifndef __deal2__time_stepping_templates_h
 #define __deal2__time_stepping_templates_h
 
-#include <deal.II/base/std_cxx1x/bind.h>
+#include <deal.II/base/std_cxx11/bind.h>
 #include <deal.II/base/exceptions.h>
 #include <deal.II/base/time_stepping.h>
 
@@ -31,8 +31,9 @@ namespace TimeStepping
 
   template <typename VECTOR>
   double RungeKutta<VECTOR>::evolve_one_time_step(
-    std::vector<std_cxx1x::function<VECTOR (const double, const VECTOR &)> > &F,
-    std::vector<std_cxx1x::function<VECTOR (const double, const double, const VECTOR &)> > &J_inverse,
+    std::vector<std_cxx11::function<VECTOR (const double, const VECTOR &)> > &F,
+    std::vector<std_cxx11::function<VECTOR (const double, const double, const VECTOR &)> > &J_inverse,
+
     double t,
     double delta_t,
     VECTOR &y)
@@ -137,8 +138,8 @@ namespace TimeStepping
 
   template <typename VECTOR>
   double ExplicitRungeKutta<VECTOR>::evolve_one_time_step(
-    std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
-    std_cxx1x::function<VECTOR (const double, const double, const VECTOR &)> id_minus_tau_J_inverse,
+    std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
+    std_cxx11::function<VECTOR (const double, const double, const VECTOR &)> id_minus_tau_J_inverse,
     double t,
     double delta_t,
     VECTOR &y)
@@ -150,7 +151,7 @@ namespace TimeStepping
 
   template <typename VECTOR>
   double ExplicitRungeKutta<VECTOR>::evolve_one_time_step(
-    std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
+    std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
     double t,
     double delta_t,
     VECTOR &y)
@@ -178,7 +179,7 @@ namespace TimeStepping
 
   template <typename VECTOR>
   void ExplicitRungeKutta<VECTOR>::compute_stages(
-    std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
+    std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
     const double t,
     const double delta_t,
     const VECTOR &y,
@@ -280,8 +281,8 @@ namespace TimeStepping
 
   template <typename VECTOR>
   double ImplicitRungeKutta<VECTOR>::evolve_one_time_step(
-    std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
-    std_cxx1x::function<VECTOR (const double, const double, const VECTOR &)> id_minus_tau_J_inverse,
+    std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
+    std_cxx11::function<VECTOR (const double, const double, const VECTOR &)> id_minus_tau_J_inverse,
     double t,
     double delta_t,
     VECTOR &y)
@@ -323,8 +324,8 @@ namespace TimeStepping
 
   template <typename VECTOR>
   void ImplicitRungeKutta<VECTOR>::compute_stages(
-    std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
-    std_cxx1x::function<VECTOR (const double, const double, const VECTOR &)> id_minus_tau_J_inverse,
+    std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
+    std_cxx11::function<VECTOR (const double, const double, const VECTOR &)> id_minus_tau_J_inverse,
     double t,
     double delta_t,
     VECTOR &y,
@@ -340,9 +341,9 @@ namespace TimeStepping
         // Solve the nonlinear system using Newton's method
         const double new_t = t+this->c[i]*delta_t;
         const double new_delta_t = this->a[i][i]*delta_t;
-        newton_solve(std_cxx1x::bind(&ImplicitRungeKutta<VECTOR>::compute_residual,this,f,new_t,new_delta_t,
-                                     std_cxx1x::cref(old_y),std_cxx1x::_1,std_cxx1x::ref(f_stages[i]),std_cxx1x::_2),
-                     std_cxx1x::bind(id_minus_tau_J_inverse,new_t,new_delta_t,std_cxx1x::_1),y);
+        newton_solve(std_cxx11::bind(&ImplicitRungeKutta<VECTOR>::compute_residual,this,f,new_t,new_delta_t,
+                                     std_cxx11::cref(old_y),std_cxx11::_1,std_cxx11::ref(f_stages[i]),std_cxx11::_2),
+                     std_cxx11::bind(id_minus_tau_J_inverse,new_t,new_delta_t,std_cxx11::_1),y);
       }
   }
 
@@ -350,8 +351,8 @@ namespace TimeStepping
 
   template <typename VECTOR>
   void ImplicitRungeKutta<VECTOR>::newton_solve(
-    std_cxx1x::function<void (const VECTOR &,VECTOR &)> get_residual,
-    std_cxx1x::function<VECTOR (const VECTOR &)> id_minus_tau_J_inverse,
+    std_cxx11::function<void (const VECTOR &,VECTOR &)> get_residual,
+    std_cxx11::function<VECTOR (const VECTOR &)> id_minus_tau_J_inverse,
     VECTOR &y)
   {
     VECTOR residual(y);
@@ -376,7 +377,7 @@ namespace TimeStepping
 
   template <typename VECTOR>
   void ImplicitRungeKutta<VECTOR>::compute_residual(
-    std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
+    std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
     double t,
     double delta_t,
     const VECTOR &old_y,
@@ -673,8 +674,8 @@ namespace TimeStepping
 
   template <typename VECTOR>
   double EmbeddedExplicitRungeKutta<VECTOR>::evolve_one_time_step(
-    std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
-    std_cxx1x::function<VECTOR (const double, const double, const VECTOR &)> id_minus_tau_J_inverse,
+    std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
+    std_cxx11::function<VECTOR (const double, const double, const VECTOR &)> id_minus_tau_J_inverse,
     double t,
     double delta_t,
     VECTOR &y)
@@ -686,7 +687,7 @@ namespace TimeStepping
 
   template <typename VECTOR>
   double EmbeddedExplicitRungeKutta<VECTOR>::evolve_one_time_step(
-    std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
+    std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
     double t, double delta_t, VECTOR &y)
   {
     bool done = false;
@@ -801,7 +802,7 @@ namespace TimeStepping
 
   template <typename VECTOR>
   void EmbeddedExplicitRungeKutta<VECTOR>::compute_stages(
-    std_cxx1x::function<VECTOR (const double, const VECTOR &)> f,
+    std_cxx11::function<VECTOR (const double, const VECTOR &)> f,
     const double t,
     const double delta_t,
     const VECTOR &y,
index ccbd6b65653dac28b174fb7e534fe46a38eb7be1..a4acdc1f0a1d98fcec8739db0aab468301dcdd24 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2008 - 2013 by the deal.II authors
+// Copyright (C) 2008 - 2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -23,8 +23,8 @@
 #include <deal.II/base/multithread_info.h>
 #include <deal.II/base/thread_management.h>
 #include <deal.II/base/template_constraints.h>
-#include <deal.II/base/std_cxx1x/function.h>
-#include <deal.II/base/std_cxx1x/bind.h>
+#include <deal.II/base/std_cxx11/function.h>
+#include <deal.II/base/std_cxx11/bind.h>
 #include <deal.II/base/thread_local_storage.h>
 #include <deal.II/base/parallel.h>
 
@@ -141,7 +141,7 @@ namespace WorkStream
   namespace internal
   {
 
-//TODO: The following classes all use std_cxx1x::shared_ptr, but the
+//TODO: The following classes all use std_cxx11::shared_ptr, but the
 //  correct pointer class would actually be std::unique_ptr. make this
 //  replacement whenever we have a class that provides these semantics
 //  and that is available also as a fall-back whenever via boost or similar
@@ -182,7 +182,7 @@ namespace WorkStream
            */
           struct ScratchDataObject
           {
-            std_cxx1x::shared_ptr<ScratchData> scratch_data;
+            std_cxx11::shared_ptr<ScratchData> scratch_data;
             bool                               currently_in_use;
 
             /**
@@ -504,7 +504,7 @@ namespace WorkStream
          * function that will do the
          * assembly.
          */
-        Worker (const std_cxx1x::function<void (const Iterator &,
+        Worker (const std_cxx11::function<void (const Iterator &,
                                                 ScratchData &,
                                                 CopyData &)> &worker,
                 bool copier_exist=true)
@@ -623,7 +623,7 @@ namespace WorkStream
          * that does the assembling
          * on the sequence of cells.
          */
-        const std_cxx1x::function<void (const Iterator &,
+        const std_cxx11::function<void (const Iterator &,
                                         ScratchData &,
                                         CopyData &)> worker;
 
@@ -661,7 +661,7 @@ namespace WorkStream
          * the global matrix or
          * similar.
          */
-        Copier (const std_cxx1x::function<void (const CopyData &)> &copier)
+        Copier (const std_cxx11::function<void (const CopyData &)> &copier)
           :
           tbb::filter (/*is_serial=*/true),
           copier (copier)
@@ -714,7 +714,7 @@ namespace WorkStream
         /**
          * Pointer to the function that does the copying of data.
          */
-        const std_cxx1x::function<void (const CopyData &)> copier;
+        const std_cxx11::function<void (const CopyData &)> copier;
       };
 
     }
@@ -751,8 +751,8 @@ namespace WorkStream
            */
           struct ScratchAndCopyDataObjects
           {
-            std_cxx1x::shared_ptr<ScratchData> scratch_data;
-            std_cxx1x::shared_ptr<CopyData>    copy_data;
+            std_cxx11::shared_ptr<ScratchData> scratch_data;
+            std_cxx11::shared_ptr<CopyData>    copy_data;
             bool                               currently_in_use;
 
             /**
@@ -1032,10 +1032,10 @@ namespace WorkStream
          * function that will do the
          * assembly.
          */
-        WorkerAndCopier (const std_cxx1x::function<void (const Iterator &,
+        WorkerAndCopier (const std_cxx11::function<void (const Iterator &,
                                                          ScratchData &,
                                                          CopyData &)> &worker,
-                         const std_cxx1x::function<void (const CopyData &)> &copier)
+                         const std_cxx11::function<void (const CopyData &)> &copier)
           :
           tbb::filter (/* is_serial= */ false),
           worker (worker),
@@ -1156,7 +1156,7 @@ namespace WorkStream
          * that does the assembling
          * on the sequence of cells.
          */
-        const std_cxx1x::function<void (const Iterator &,
+        const std_cxx11::function<void (const Iterator &,
                                         ScratchData &,
                                         CopyData &)> worker;
 
@@ -1164,7 +1164,7 @@ namespace WorkStream
          * Pointer to the function that does the copying from
          * local contribution to global object.
          */
-        const std_cxx1x::function<void (const CopyData &)> copier;
+        const std_cxx11::function<void (const CopyData &)> copier;
       };
     }
 
@@ -1187,7 +1187,7 @@ namespace WorkStream
         /**
          * Constructor.
          */
-        Worker (const std_cxx1x::function<void (const Iterator &,
+        Worker (const std_cxx11::function<void (const Iterator &,
                                                 ScratchData &,
                                                 CopyData &)> &worker,
                 const ScratchData    &sample_scratch_data,
@@ -1308,7 +1308,7 @@ namespace WorkStream
          * that does the assembling
          * on the sequence of cells.
          */
-        const std_cxx1x::function<void (const Iterator &,
+        const std_cxx11::function<void (const Iterator &,
                                         ScratchData &,
                                         CopyData &)> worker;
 
@@ -1453,11 +1453,11 @@ namespace WorkStream
           {
             // need to check if the function is not the zero function. To
             // check zero-ness, create a C++ function out of it and check that
-            if (static_cast<const std_cxx1x::function<void (const Iterator &,
+            if (static_cast<const std_cxx11::function<void (const Iterator &,
                                                             ScratchData &,
                                                             CopyData &)>& >(worker))
               worker (i, scratch_data, copy_data);
-            if (static_cast<const std_cxx1x::function<void (const CopyData &)>& >
+            if (static_cast<const std_cxx11::function<void (const CopyData &)>& >
                 (copier))
               copier (copy_data);
           }
@@ -1466,7 +1466,7 @@ namespace WorkStream
     else // have TBB and use more than one thread
       {
         // Check that the copier exist
-        if (static_cast<const std_cxx1x::function<void (const CopyData &)>& >(copier))
+        if (static_cast<const std_cxx11::function<void (const CopyData &)>& >(copier))
           {
             // create the three stages of the pipeline
             internal::Implementation2::IteratorRangeToItemStream<Iterator,ScratchData,CopyData>
@@ -1561,11 +1561,11 @@ namespace WorkStream
             {
               // need to check if the function is not the zero function. To
               // check zero-ness, create a C++ function out of it and check that
-              if (static_cast<const std_cxx1x::function<void (const Iterator &,
+              if (static_cast<const std_cxx11::function<void (const Iterator &,
                                                               ScratchData &,
                                                               CopyData &)>& >(worker))
                 worker (*p, scratch_data, copy_data);
-              if (static_cast<const std_cxx1x::function<void (const CopyData &)>& >(copier))
+              if (static_cast<const std_cxx11::function<void (const CopyData &)>& >(copier))
                 copier (copy_data);
             }
       }
@@ -1576,7 +1576,7 @@ namespace WorkStream
         for (unsigned int color=0; color<colored_iterators.size(); ++color)
           if (colored_iterators[color].size() > 0)
             {
-              if (static_cast<const std_cxx1x::function<void (const CopyData &)>& >(copier))
+              if (static_cast<const std_cxx11::function<void (const CopyData &)>& >(copier))
                 {
                   // there is a copier function, so we have to go with
                   // the full three-stage design of the pipeline
@@ -1605,7 +1605,7 @@ namespace WorkStream
               else
                 {
                   // no copier function, we can implement things as a parallel for
-                  Assert (static_cast<const std_cxx1x::function<void (const Iterator &,
+                  Assert (static_cast<const std_cxx11::function<void (const Iterator &,
                                                                       ScratchData &,
                                                                       CopyData &)>& >(worker),
                           ExcMessage ("It makes no sense to call this function with "
@@ -1628,9 +1628,9 @@ namespace WorkStream
                                      (colored_iterators[color].begin(),
                                       colored_iterators[color].end(),
                                       /*grain_size=*/chunk_size),
-                                     std_cxx1x::bind (&ParallelForWorker::operator(),
-                                                      std_cxx1x::ref(parallel_for_worker),
-                                                      std_cxx1x::_1),
+                                     std_cxx11::bind (&ParallelForWorker::operator(),
+                                                      std_cxx11::ref(parallel_for_worker),
+                                                      std_cxx11::_1),
                                      tbb::auto_partitioner());
                 }
             }
@@ -1689,12 +1689,12 @@ namespace WorkStream
   {
     // forward to the other function
     run (begin, end,
-         std_cxx1x::bind (worker,
-                          std_cxx1x::ref (main_object),
-                          std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3),
-         std_cxx1x::bind (copier,
-                          std_cxx1x::ref (main_object),
-                          std_cxx1x::_1),
+         std_cxx11::bind (worker,
+                          std_cxx11::ref (main_object),
+                          std_cxx11::_1, std_cxx11::_2, std_cxx11::_3),
+         std_cxx11::bind (copier,
+                          std_cxx11::ref (main_object),
+                          std_cxx11::_1),
          sample_scratch_data,
          sample_copy_data,
          queue_length,
index 740231ebe39a8a1381afba900677cc76db022caa..542e514898966a6c13c9dca279321ece05558b0c 100644 (file)
@@ -24,8 +24,8 @@
 #include <deal.II/base/template_constraints.h>
 #include <deal.II/grid/tria.h>
 
-#include <deal.II/base/std_cxx1x/function.h>
-#include <deal.II/base/std_cxx1x/tuple.h>
+#include <deal.II/base/std_cxx11/function.h>
+#include <deal.II/base/std_cxx11/tuple.h>
 
 #include <set>
 #include <vector>
@@ -233,7 +233,7 @@ namespace parallel
      * into the function. C++ provides a nice mechanism for this that is best
      * explained using an example:
      * @code
-     *     #include <deal.II/base/std_cxx1x/bind.h>
+     *     #include <deal.II/base/std_cxx11/bind.h>
      *
      *     template <int dim>
      *     void set_boundary_indicators (parallel::distributed::Triangulation<dim> &triangulation)
@@ -249,13 +249,13 @@ namespace parallel
      *       ... create the coarse mesh ...
      *
      *       coarse_grid.signals.post_refinement.connect
-     *         (std_cxx1x::bind (&set_boundary_indicators<dim>,
-     *                           std_cxx1x::ref(coarse_grid)));
+     *         (std_cxx11::bind (&set_boundary_indicators<dim>,
+     *                           std_cxx11::ref(coarse_grid)));
      *
      *     }
      * @endcode
      *
-     * What the call to <code>std_cxx1x::bind</code> does is to produce an object that
+     * What the call to <code>std_cxx11::bind</code> does is to produce an object that
      * can be called like a function with no arguments. It does so by taking the
      * address of a function that does, in fact, take an argument but permanently fix
      * this one argument to a reference to the coarse grid triangulation. After each
@@ -271,7 +271,7 @@ namespace parallel
      * function has been declared as a (non-static, but possibly private) member
      * function of the <code>MyClass</code> class, then the following will work:
      * @code
-     *     #include <deal.II/base/std_cxx1x/bind.h>
+     *     #include <deal.II/base/std_cxx11/bind.h>
      *
      *     template <int dim>
      *     void
@@ -289,9 +289,9 @@ namespace parallel
      *       ... create the coarse mesh ...
      *
      *       coarse_grid.signals.post_refinement.connect
-     *         (std_cxx1x::bind (&MyGeometry<dim>::set_boundary_indicators,
-     *                           std_cxx1x::cref(*this),
-     *                           std_cxx1x::ref(coarse_grid)));
+     *         (std_cxx11::bind (&MyGeometry<dim>::set_boundary_indicators,
+     *                           std_cxx11::cref(*this),
+     *                           std_cxx11::ref(coarse_grid)));
      *     }
      * @endcode
      * Here, like any other member function, <code>set_boundary_indicators</code>
@@ -673,7 +673,7 @@ namespace parallel
        */
       unsigned int
       register_data_attach (const std::size_t size,
-                            const std_cxx1x::function<void (const cell_iterator &,
+                            const std_cxx11::function<void (const cell_iterator &,
                                                             const CellStatus,
                                                             void *)> &pack_callback);
 
@@ -693,7 +693,7 @@ namespace parallel
        */
       void
       notify_ready_to_unpack (const unsigned int offset,
-                              const std_cxx1x::function<void (const cell_iterator &,
+                              const std_cxx11::function<void (const cell_iterator &,
                                                               const CellStatus,
                                                               const void *)> &unpack_callback);
 
@@ -822,7 +822,7 @@ namespace parallel
        */
       unsigned int n_attached_deserialize;
 
-      typedef  std_cxx1x::function<
+      typedef  std_cxx11::function<
       void(typename Triangulation<dim,spacedim>::cell_iterator, CellStatus, void *)
       > pack_callback_t;
 
index df011c759c6078efcbde2509a4fd4cf64151d589..94d7e3169a11d335a5422b07d55a8b30b55e8431 100644 (file)
@@ -24,7 +24,7 @@
 #include <deal.II/base/smartpointer.h>
 #include <deal.II/base/index_set.h>
 #include <deal.II/base/iterator_range.h>
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 #include <deal.II/dofs/block_info.h>
 #include <deal.II/dofs/dof_iterator_selector.h>
 #include <deal.II/dofs/number_cache.h>
@@ -1109,7 +1109,7 @@ protected:
    * of freedom should be distributed and
    * renumbered.
    */
-  std_cxx1x::shared_ptr<dealii::internal::DoFHandler::Policy::PolicyBase<dim,spacedim> > policy;
+  std_cxx11::shared_ptr<dealii::internal::DoFHandler::Policy::PolicyBase<dim,spacedim> > policy;
 
   /**
    * A structure that contains all
index 362e113fa2fbce659d4295a654c6a083c4f2eefa..3d3836de315cd782b57c51d75f6337380236356b 100644 (file)
@@ -705,7 +705,7 @@ private:
    * pointers to the underlying base finite elements. The last one of these
    * copies around will then delete the pointer to the base elements.
    */
-  std::vector<std::pair<std_cxx1x::shared_ptr<const FiniteElement<dim,spacedim> >,
+  std::vector<std::pair<std_cxx11::shared_ptr<const FiniteElement<dim,spacedim> >,
       unsigned int> >
       base_elements;
 
index 1eacc53dc021435977f100ce8bd300890ae67d4d..f152816995a5e26c454fd0b4be888e2851d6160a 100644 (file)
@@ -24,7 +24,7 @@
 #include <deal.II/base/smartpointer.h>
 #include <deal.II/base/geometry_info.h>
 #include <deal.II/base/iterator_range.h>
-#include <deal.II/base/std_cxx1x/function.h>
+#include <deal.II/base/std_cxx11/function.h>
 #include <deal.II/grid/tria_iterator_selector.h>
 #include <deal.II/grid/tria_faces.h>
 #include <deal.II/grid/tria_levels.h>
@@ -1029,8 +1029,8 @@ namespace internal
  *           // mesh refinement
  *           previous_cell = current_cell;
  *           previous_cell.get_tria().signals.post_refinement
- *             .connect (std_cxx1x::bind (&FEValues<dim>::invalidate_previous_cell,
- *                                        std_cxx1x::ref (*this)));
+ *             .connect (std_cxx11::bind (&FEValues<dim>::invalidate_previous_cell,
+ *                                        std_cxx11::ref (*this)));
  *         }
  *       else
  *         previous_cell = current_cell;
index 9ee79ac5e7b6d943791c4091c57a33ce2e82b402..cb2835ae5d97d22caaa86952a07104b7e3848e5c 100644 (file)
@@ -269,7 +269,7 @@ private:
   /**
    * Point generator for the intermediate points on a boundary.
    */
-  mutable std::vector<std_cxx1x::shared_ptr<QGaussLobatto<1> > > points;
+  mutable std::vector<std_cxx11::shared_ptr<QGaussLobatto<1> > > points;
 
   /**
    * Mutex for protecting the points array.
index def9cc371ef107237e0b7daab0a7a137ca186905..7139937b26d5fb69e50d474632a8f3c2197e4a4b 100644 (file)
@@ -18,7 +18,7 @@
 #define __deal2__fe_collection_h
 
 #include <deal.II/base/config.h>
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 #include <deal.II/fe/fe.h>
 #include <deal.II/fe/fe_values_extractors.h>
 #include <deal.II/fe/component_mask.h>
@@ -438,7 +438,7 @@ namespace hp
      * Array of pointers to the finite
      * elements stored by this collection.
      */
-    std::vector<std_cxx1x::shared_ptr<const FiniteElement<dim,spacedim> > > finite_elements;
+    std::vector<std_cxx11::shared_ptr<const FiniteElement<dim,spacedim> > > finite_elements;
   };
 
 
index c4d14caa6d370158e96881d41f6f3fdeb58e4b5e..cc00c03ebf1b893d95cc905235d0ebd20c8567cf 100644 (file)
@@ -25,7 +25,7 @@
 #include <deal.II/fe/fe_values.h>
 
 #include <map>
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -158,7 +158,7 @@ namespace internal
        * Initially, all entries have zero pointers, and we will allocate them
        * lazily as needed in select_fe_values().
        */
-      dealii::Table<3,std_cxx1x::shared_ptr<FEValues> > fe_values_table;
+      dealii::Table<3,std_cxx11::shared_ptr<FEValues> > fe_values_table;
 
       /**
        * Set of indices pointing at the fe_values object selected last time
index e187cfdc35895405f57b142ee18a370f85846857..82ca73477c9bcfc20a3b14497c7cbc2ffb918b97 100644 (file)
@@ -23,7 +23,7 @@
 #include <deal.II/fe/fe.h>
 
 #include <vector>
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -132,7 +132,7 @@ namespace hp
      * pointers to the different Mapping
      * objects.
      */
-    std::vector<std_cxx1x::shared_ptr<const Mapping<dim,spacedim> > > mappings;
+    std::vector<std_cxx11::shared_ptr<const Mapping<dim,spacedim> > > mappings;
   };
 
 
index 2b556ddb26cc0d9df77700a17698fa06eb2fd738..15e4a9846e154a4d15ced31eaf5fb9959ad20dd2 100644 (file)
@@ -24,7 +24,7 @@
 #include <deal.II/fe/fe.h>
 
 #include <vector>
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -149,7 +149,7 @@ namespace hp
      * pointers to the different quadrature
      * objects.
      */
-    std::vector<std_cxx1x::shared_ptr<const Quadrature<dim> > > quadratures;
+    std::vector<std_cxx11::shared_ptr<const Quadrature<dim> > > quadratures;
   };
 
 
@@ -208,7 +208,7 @@ namespace hp
   QCollection<dim>::QCollection (const Quadrature<dim> &quadrature)
   {
     quadratures
-    .push_back (std_cxx1x::shared_ptr<const Quadrature<dim> >(new Quadrature<dim>(quadrature)));
+    .push_back (std_cxx11::shared_ptr<const Quadrature<dim> >(new Quadrature<dim>(quadrature)));
   }
 
 
@@ -251,7 +251,7 @@ namespace hp
   QCollection<dim>::push_back (const Quadrature<dim> &new_quadrature)
   {
     quadratures
-    .push_back (std_cxx1x::shared_ptr<const Quadrature<dim> >(new Quadrature<dim>(new_quadrature)));
+    .push_back (std_cxx11::shared_ptr<const Quadrature<dim> >(new Quadrature<dim>(new_quadrature)));
   }
 
 } // namespace hp
index bc7f6a323a61909129dc8a49a37d8d080511e670..1a241b42d785dbe3f7d39235e4cde6a4c04dd100 100644 (file)
@@ -404,9 +404,9 @@ ChunkSparseMatrix<number>::operator = (const double d)
     (matrix_size+m()) / m();
   if (matrix_size>grain_size)
     parallel::apply_to_subranges (0U, matrix_size,
-                                  std_cxx1x::bind(&internal::ChunkSparseMatrix::template
+                                  std_cxx11::bind(&internal::ChunkSparseMatrix::template
                                                   zero_subrange<number>,
-                                                  std_cxx1x::_1, std_cxx1x::_2,
+                                                  std_cxx11::_1, std_cxx11::_2,
                                                   val),
                                   grain_size);
   else if (matrix_size > 0)
@@ -711,15 +711,15 @@ ChunkSparseMatrix<number>::vmult_add (OutVector &dst,
 
   Assert (!PointerComparison::equal(&src, &dst), ExcSourceEqualsDestination());
   parallel::apply_to_subranges (0U, cols->sparsity_pattern.n_rows(),
-                                std_cxx1x::bind (&internal::ChunkSparseMatrix::vmult_add_on_subrange
+                                std_cxx11::bind (&internal::ChunkSparseMatrix::vmult_add_on_subrange
                                                  <number,InVector,OutVector>,
-                                                 std_cxx1x::cref(*cols),
-                                                 std_cxx1x::_1, std_cxx1x::_2,
+                                                 std_cxx11::cref(*cols),
+                                                 std_cxx11::_1, std_cxx11::_2,
                                                  val,
                                                  cols->sparsity_pattern.rowstart,
                                                  cols->sparsity_pattern.colnums,
-                                                 std_cxx1x::cref(src),
-                                                 std_cxx1x::ref(dst)),
+                                                 std_cxx11::cref(src),
+                                                 std_cxx11::ref(dst)),
                                 internal::SparseMatrix::minimum_parallel_grain_size/cols->chunk_size+1);
 
 }
index 074613fc5fd2e61cf510fec48319ce75417310bb..a73c4aeefc896febf3d4f777362ffa2a179bc7d9 100644 (file)
@@ -617,7 +617,7 @@ private:
    * pattern used for this
    * matrix.
    */
-  std_cxx1x::shared_ptr<PointerMatrixBase<VECTOR> > matrix;
+  std_cxx11::shared_ptr<PointerMatrixBase<VECTOR> > matrix;
 
   /**
    * Sorted list of pairs denoting
index 0fe4432028280b30130cd00f09c27ef86b6fd005..ef2c71006dc3c6c06b01a8f075f6018466c0f7b1 100644 (file)
@@ -118,12 +118,12 @@ private:
   /**
    * The matrix in use.
    */
-  std_cxx1x::shared_ptr<PointerMatrixBase<VECTOR> > matrix;
+  std_cxx11::shared_ptr<PointerMatrixBase<VECTOR> > matrix;
 
   /**
    * The preconditioner to use.
    */
-  std_cxx1x::shared_ptr<PointerMatrixBase<VECTOR> > preconditioner;
+  std_cxx11::shared_ptr<PointerMatrixBase<VECTOR> > preconditioner;
 };
 
 
@@ -135,8 +135,8 @@ IterativeInverse<VECTOR>::initialize(const MATRIX &m, const PRECONDITION &p)
 {
   // dummy variable
   VECTOR *v = 0;
-  matrix = std_cxx1x::shared_ptr<PointerMatrixBase<VECTOR> > (new_pointer_matrix_base(m, *v));
-  preconditioner = std_cxx1x::shared_ptr<PointerMatrixBase<VECTOR> > (new_pointer_matrix_base(p, *v));
+  matrix = std_cxx11::shared_ptr<PointerMatrixBase<VECTOR> > (new_pointer_matrix_base(m, *v));
+  preconditioner = std_cxx11::shared_ptr<PointerMatrixBase<VECTOR> > (new_pointer_matrix_base(p, *v));
 }
 
 
index ecf8c9132cb817228d1daf048ce9bb20a2f0f44e..30be840792d9dc27329879feefcc334295cdca64 100644 (file)
@@ -24,7 +24,7 @@
 #include <deal.II/lac/lapack_support.h>
 #include <deal.II/lac/vector_memory.h>
 
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 #include <vector>
 #include <complex>
 
@@ -638,13 +638,13 @@ private:
    * The matrix <i>U</i> in the singular value decomposition
    * <i>USV<sup>T</sup></i>.
    */
-  std_cxx1x::shared_ptr<LAPACKFullMatrix<number> > svd_u;
+  std_cxx11::shared_ptr<LAPACKFullMatrix<number> > svd_u;
 
   /**
    * The matrix <i>V<sup>T</sup></i> in the singular value decomposition
    * <i>USV<sup>T</sup></i>.
    */
-  std_cxx1x::shared_ptr<LAPACKFullMatrix<number> > svd_vt;
+  std_cxx11::shared_ptr<LAPACKFullMatrix<number> > svd_vt;
 };
 
 
index b72414d085aa74bd975ecbefee043bf85948a354..df119e725d7df220f5f2525a0fb26b1d6cef7682 100644 (file)
@@ -20,7 +20,7 @@
 #include <deal.II/base/config.h>
 #include <deal.II/base/named_data.h>
 #include <deal.II/base/smartpointer.h>
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 #include <deal.II/base/memory_consumption.h>
 #include <deal.II/base/mg_level_object.h>
 #include <deal.II/lac/block_indices.h>
@@ -415,7 +415,7 @@ private:
 template <class MATRIX>
 class MatrixBlockVector
   :
-  private NamedData<std_cxx1x::shared_ptr<MatrixBlock<MATRIX> > >
+  private NamedData<std_cxx11::shared_ptr<MatrixBlock<MATRIX> > >
 {
 public:
   /**
@@ -490,10 +490,10 @@ public:
   /**
    * import functions from private base class
    */
-  using NamedData<std_cxx1x::shared_ptr<value_type> >::subscribe;
-  using NamedData<std_cxx1x::shared_ptr<value_type> >::unsubscribe;
-  using NamedData<std_cxx1x::shared_ptr<value_type> >::size;
-  using NamedData<std_cxx1x::shared_ptr<value_type> >::name;
+  using NamedData<std_cxx11::shared_ptr<value_type> >::subscribe;
+  using NamedData<std_cxx11::shared_ptr<value_type> >::unsubscribe;
+  using NamedData<std_cxx11::shared_ptr<value_type> >::size;
+  using NamedData<std_cxx11::shared_ptr<value_type> >::name;
 };
 
 
@@ -956,8 +956,8 @@ MatrixBlockVector<MATRIX>::add(
   size_type row, size_type column,
   const std::string &name)
 {
-  std_cxx1x::shared_ptr<value_type> p(new value_type(row, column));
-  NamedData<std_cxx1x::shared_ptr<value_type> >::add(p, name);
+  std_cxx11::shared_ptr<value_type> p(new value_type(row, column));
+  NamedData<std_cxx11::shared_ptr<value_type> >::add(p, name);
 }
 
 
index 44c91f1745b72f60047dd0f24e07d843c8a512ee..b58809d97e707eba7baa188e0e32a8e18b150569 100644 (file)
@@ -214,7 +214,7 @@ namespace parallel
        * partitioner data only once and share it between several vectors with
        * the same layout.
        */
-      Vector (const std_cxx1x::shared_ptr<const Utilities::MPI::Partitioner> &partitioner);
+      Vector (const std_cxx11::shared_ptr<const Utilities::MPI::Partitioner> &partitioner);
 
       /**
        * Destructor.
@@ -270,7 +270,7 @@ namespace parallel
        * the partitioner data only once and share it between several vectors
        * with the same layout.
        */
-      void reinit (const std_cxx1x::shared_ptr<const Utilities::MPI::Partitioner> &partitioner);
+      void reinit (const std_cxx11::shared_ptr<const Utilities::MPI::Partitioner> &partitioner);
 
       /**
        * Swap the contents of this vector and the other vector @p v. One could
@@ -1005,7 +1005,7 @@ namespace parallel
        * information can be shared between several vectors that have the same
        * partitioning.
        */
-      std_cxx1x::shared_ptr<const Utilities::MPI::Partitioner> partitioner;
+      std_cxx11::shared_ptr<const Utilities::MPI::Partitioner> partitioner;
 
       /**
        * The size that is currently allocated in the val array.
@@ -1177,7 +1177,7 @@ namespace parallel
     template <typename Number>
     inline
     Vector<Number>::
-    Vector (const std_cxx1x::shared_ptr<const Utilities::MPI::Partitioner> &partitioner)
+    Vector (const std_cxx11::shared_ptr<const Utilities::MPI::Partitioner> &partitioner)
       :
       allocated_size (0),
       val (0),
index 1301658d916928a5082b762202a82c912d6f758a..6438050572609a8223fce64ee0e8375b1a12550b 100644 (file)
@@ -153,7 +153,7 @@ namespace parallel
                             const MPI_Comm  communicator)
     {
       // set up parallel partitioner with index sets and communicator
-      std_cxx1x::shared_ptr<const Utilities::MPI::Partitioner> new_partitioner
+      std_cxx11::shared_ptr<const Utilities::MPI::Partitioner> new_partitioner
       (new Utilities::MPI::Partitioner (locally_owned_indices,
                                         ghost_indices, communicator));
       reinit (new_partitioner);
@@ -168,7 +168,7 @@ namespace parallel
     {
       // set up parallel partitioner with index sets and communicator
       IndexSet ghost_indices(locally_owned_indices.size());
-      std_cxx1x::shared_ptr<const Utilities::MPI::Partitioner> new_partitioner
+      std_cxx11::shared_ptr<const Utilities::MPI::Partitioner> new_partitioner
       (new Utilities::MPI::Partitioner (locally_owned_indices,
                                         ghost_indices, communicator));
       reinit (new_partitioner);
@@ -178,7 +178,7 @@ namespace parallel
 
     template <typename Number>
     void
-    Vector<Number>::reinit (const std_cxx1x::shared_ptr<const Utilities::MPI::Partitioner> &partitioner_in)
+    Vector<Number>::reinit (const std_cxx11::shared_ptr<const Utilities::MPI::Partitioner> &partitioner_in)
     {
       clear_mpi_requests();
       partitioner = partitioner_in;
index 870647f24cc2096a506a56795d1262dc51513707..26bc96deeca1ce32e0c5d1521458e5474fb8ed97 100644 (file)
@@ -28,7 +28,7 @@
 #  include <deal.II/lac/vector.h>
 
 #  include <petscmat.h>
-#  include <deal.II/base/std_cxx1x/shared_ptr.h>
+#  include <deal.II/base/std_cxx11/shared_ptr.h>
 
 #  include <vector>
 #  include <cmath>
@@ -169,13 +169,13 @@ namespace PETScWrappers
          * accessor can access this data
          * if necessary.
          */
-        std_cxx1x::shared_ptr<const std::vector<size_type> > colnum_cache;
+        std_cxx11::shared_ptr<const std::vector<size_type> > colnum_cache;
 
         /**
          * Similar cache for the values
          * of this row.
          */
-        std_cxx1x::shared_ptr<const std::vector<PetscScalar> > value_cache;
+        std_cxx11::shared_ptr<const std::vector<PetscScalar> > value_cache;
 
         /**
          * Discard the old row caches
index b87797cd4f024a405b73f2a5d655182ec36d6e31..7685f2c83bb60dc8a5b16b45824a32cba6ddf7de 100644 (file)
@@ -24,7 +24,7 @@
 
 #  include <deal.II/lac/exceptions.h>
 #  include <deal.II/lac/solver_control.h>
-#  include <deal.II/base/std_cxx1x/shared_ptr.h>
+#  include <deal.II/base/std_cxx11/shared_ptr.h>
 
 #  include <petscksp.h>
 
@@ -280,7 +280,7 @@ namespace PETScWrappers
      * the main solver routine if
      * necessary.
      */
-    std_cxx1x::shared_ptr<SolverData> solver_data;
+    std_cxx11::shared_ptr<SolverData> solver_data;
   };
 
 
@@ -1242,7 +1242,7 @@ namespace PETScWrappers
       PC  pc;
     };
 
-    std_cxx1x::shared_ptr<SolverDataMUMPS> solver_data;
+    std_cxx11::shared_ptr<SolverDataMUMPS> solver_data;
 
     /**
      * Flag specifies whether matrix
index ded75613d4aa7aaa7d51af53ff6854e4835bf263..73ab3f4ca036858cec5b926efae6ca4694bbf6b8 100644 (file)
@@ -22,7 +22,7 @@
 
 #ifdef DEAL_II_WITH_SLEPC
 
-#  include <deal.II/base/std_cxx1x/shared_ptr.h>
+#  include <deal.II/base/std_cxx11/shared_ptr.h>
 #  include <deal.II/lac/exceptions.h>
 #  include <deal.II/lac/solver_control.h>
 #  include <deal.II/lac/petsc_matrix_base.h>
@@ -425,7 +425,7 @@ namespace SLEPcWrappers
     /**
      * Pointer to the <code>SolverData</code> object.
      */
-    std_cxx1x::shared_ptr<SolverData> solver_data;
+    std_cxx11::shared_ptr<SolverData> solver_data;
   };
 
   /**
index 4449b2e41e971632edbb1a3b70e0c9951aee9a24..83de2f06c734cef65fab221309e1163848075b18 100644 (file)
@@ -23,7 +23,7 @@
 
 #ifdef DEAL_II_WITH_SLEPC
 
-#  include <deal.II/base/std_cxx1x/shared_ptr.h>
+#  include <deal.II/base/std_cxx11/shared_ptr.h>
 #  include <deal.II/lac/exceptions.h>
 
 #  include <petscksp.h>
@@ -117,7 +117,7 @@ namespace SLEPcWrappers
       ST st;
     };
 
-    std_cxx1x::shared_ptr<TransformationData> transformation_data;
+    std_cxx11::shared_ptr<TransformationData> transformation_data;
   };
 
   /**
index 4c410ed5ed183fc8253bca946b3802d8778435ba..e5490c145e81734277f4338da5edb95151a54363 100644 (file)
@@ -38,7 +38,7 @@
 #include <cmath>
 #include <vector>
 #include <numeric>
-#include <deal.II/base/std_cxx1x/bind.h>
+#include <deal.II/base/std_cxx11/bind.h>
 
 
 
@@ -164,9 +164,9 @@ SparseMatrix<number>::operator = (const double d)
     (cols->n_nonzero_elements()+m()) / m();
   if (matrix_size>grain_size)
     parallel::apply_to_subranges (0U, matrix_size,
-                                  std_cxx1x::bind(&internal::SparseMatrix::template
+                                  std_cxx11::bind(&internal::SparseMatrix::template
                                                   zero_subrange<number>,
-                                                  std_cxx1x::_1, std_cxx1x::_2,
+                                                  std_cxx11::_1, std_cxx11::_2,
                                                   val),
                                   grain_size);
   else if (matrix_size > 0)
@@ -715,14 +715,14 @@ SparseMatrix<number>::vmult (OutVector &dst,
   Assert (!PointerComparison::equal(&src, &dst), ExcSourceEqualsDestination());
 
   parallel::apply_to_subranges (0U, m(),
-                                std_cxx1x::bind (&internal::SparseMatrix::vmult_on_subrange
+                                std_cxx11::bind (&internal::SparseMatrix::vmult_on_subrange
                                                  <number,InVector,OutVector>,
-                                                 std_cxx1x::_1, std_cxx1x::_2,
+                                                 std_cxx11::_1, std_cxx11::_2,
                                                  val,
                                                  cols->rowstart,
                                                  cols->colnums,
-                                                 std_cxx1x::cref(src),
-                                                 std_cxx1x::ref(dst),
+                                                 std_cxx11::cref(src),
+                                                 std_cxx11::ref(dst),
                                                  false),
                                 internal::SparseMatrix::minimum_parallel_grain_size);
 }
@@ -770,14 +770,14 @@ SparseMatrix<number>::vmult_add (OutVector &dst,
   Assert (!PointerComparison::equal(&src, &dst), ExcSourceEqualsDestination());
 
   parallel::apply_to_subranges (0U, m(),
-                                std_cxx1x::bind (&internal::SparseMatrix::vmult_on_subrange
+                                std_cxx11::bind (&internal::SparseMatrix::vmult_on_subrange
                                                  <number,InVector,OutVector>,
-                                                 std_cxx1x::_1, std_cxx1x::_2,
+                                                 std_cxx11::_1, std_cxx11::_2,
                                                  val,
                                                  cols->rowstart,
                                                  cols->colnums,
-                                                 std_cxx1x::cref(src),
-                                                 std_cxx1x::ref(dst),
+                                                 std_cxx11::cref(src),
+                                                 std_cxx11::ref(dst),
                                                  true),
                                 internal::SparseMatrix::minimum_parallel_grain_size);
 }
@@ -858,11 +858,11 @@ SparseMatrix<number>::matrix_norm_square (const Vector<somenumber> &v) const
 
   return
     parallel::accumulate_from_subranges<number>
-    (std_cxx1x::bind (&internal::SparseMatrix::matrix_norm_sqr_on_subrange
+    (std_cxx11::bind (&internal::SparseMatrix::matrix_norm_sqr_on_subrange
                       <number,Vector<somenumber> >,
-                      std_cxx1x::_1, std_cxx1x::_2,
+                      std_cxx11::_1, std_cxx11::_2,
                       val, cols->rowstart, cols->colnums,
-                      std_cxx1x::cref(v)),
+                      std_cxx11::cref(v)),
      0, m(),
      internal::SparseMatrix::minimum_parallel_grain_size);
 }
@@ -923,12 +923,12 @@ SparseMatrix<number>::matrix_scalar_product (const Vector<somenumber> &u,
 
   return
     parallel::accumulate_from_subranges<number>
-    (std_cxx1x::bind (&internal::SparseMatrix::matrix_scalar_product_on_subrange
+    (std_cxx11::bind (&internal::SparseMatrix::matrix_scalar_product_on_subrange
                       <number,Vector<somenumber> >,
-                      std_cxx1x::_1, std_cxx1x::_2,
+                      std_cxx11::_1, std_cxx11::_2,
                       val, cols->rowstart, cols->colnums,
-                      std_cxx1x::cref(u),
-                      std_cxx1x::cref(v)),
+                      std_cxx11::cref(u),
+                      std_cxx11::cref(v)),
      0, m(),
      internal::SparseMatrix::minimum_parallel_grain_size);
 }
@@ -1312,13 +1312,13 @@ SparseMatrix<number>::residual (Vector<somenumber>       &dst,
 
   return
     std::sqrt (parallel::accumulate_from_subranges<number>
-               (std_cxx1x::bind (&internal::SparseMatrix::residual_sqr_on_subrange
+               (std_cxx11::bind (&internal::SparseMatrix::residual_sqr_on_subrange
                                  <number,Vector<somenumber>,Vector<somenumber> >,
-                                 std_cxx1x::_1, std_cxx1x::_2,
+                                 std_cxx11::_1, std_cxx11::_2,
                                  val, cols->rowstart, cols->colnums,
-                                 std_cxx1x::cref(u),
-                                 std_cxx1x::cref(b),
-                                 std_cxx1x::ref(dst)),
+                                 std_cxx11::cref(u),
+                                 std_cxx11::cref(b),
+                                 std_cxx11::ref(dst)),
                 0, m(),
                 internal::SparseMatrix::minimum_parallel_grain_size));
 }
index 8877d031dff9bc64655727e3a7e5d5cb1e47d95d..8e282b1a244fd8b5d04a88f492402de5d2305dae 100644 (file)
@@ -23,7 +23,7 @@
 #ifdef DEAL_II_WITH_TRILINOS
 
 #  include <deal.II/base/subscriptor.h>
-#  include <deal.II/base/std_cxx1x/shared_ptr.h>
+#  include <deal.II/base/std_cxx11/shared_ptr.h>
 
 #  include <deal.II/lac/trilinos_vector_base.h>
 #  include <deal.II/lac/parallel_vector.h>
@@ -170,7 +170,7 @@ namespace TrilinosWrappers
      * This is a pointer to the preconditioner object that is used when
      * applying the preconditioner.
      */
-    std_cxx1x::shared_ptr<Epetra_Operator> preconditioner;
+    std_cxx11::shared_ptr<Epetra_Operator> preconditioner;
 
     /**
      * Internal communication pattern in case the matrix needs to be copied
@@ -186,7 +186,7 @@ namespace TrilinosWrappers
      * Internal Trilinos map in case the matrix needs to be copied from
      * deal.II format.
      */
-    std_cxx1x::shared_ptr<Epetra_Map>   vector_distributor;
+    std_cxx11::shared_ptr<Epetra_Map>   vector_distributor;
   };
 
 
@@ -1557,7 +1557,7 @@ namespace TrilinosWrappers
     /**
      * A copy of the deal.II matrix into Trilinos format.
      */
-    std_cxx1x::shared_ptr<SparseMatrix> trilinos_matrix;
+    std_cxx11::shared_ptr<SparseMatrix> trilinos_matrix;
   };
 
 
index 4a47aec813f4ba5bd1a80408bab07648fe0a7463..42f39c18fca41be695b5e32ea3ecc6697d397d63 100644 (file)
@@ -22,7 +22,7 @@
 
 #ifdef DEAL_II_WITH_TRILINOS
 
-#  include <deal.II/base/std_cxx1x/shared_ptr.h>
+#  include <deal.II/base/std_cxx11/shared_ptr.h>
 #  include <deal.II/lac/exceptions.h>
 #  include <deal.II/lac/solver_control.h>
 #  include <deal.II/lac/vector.h>
@@ -243,7 +243,7 @@ namespace TrilinosWrappers
      * side vector and the solution vector, which is passed down to the
      * Trilinos solver.
      */
-    std_cxx1x::shared_ptr<Epetra_LinearProblem> linear_problem;
+    std_cxx11::shared_ptr<Epetra_LinearProblem> linear_problem;
 
     /**
      * A structure that contains the Trilinos solver and preconditioner
@@ -633,13 +633,13 @@ namespace TrilinosWrappers
      * side vector and the solution vector, which is passed down to the
      * Trilinos solver.
      */
-    std_cxx1x::shared_ptr<Epetra_LinearProblem> linear_problem;
+    std_cxx11::shared_ptr<Epetra_LinearProblem> linear_problem;
 
     /**
      * A structure that contains the Trilinos solver and preconditioner
      * objects.
      */
-    std_cxx1x::shared_ptr<Amesos_BaseSolver> solver;
+    std_cxx11::shared_ptr<Amesos_BaseSolver> solver;
 
     /**
      * Store a copy of the flags for this particular solver.
index 467b60fed38f30324cd22cdd9b3043f2795d7441..5484aa62e6ec2d384322deb8db66db48c86bcb32 100644 (file)
@@ -22,7 +22,7 @@
 
 #ifdef DEAL_II_WITH_TRILINOS
 
-#  include <deal.II/base/std_cxx1x/shared_ptr.h>
+#  include <deal.II/base/std_cxx11/shared_ptr.h>
 #  include <deal.II/base/subscriptor.h>
 #  include <deal.II/base/index_set.h>
 #  include <deal.II/lac/full_matrix.h>
@@ -163,12 +163,12 @@ namespace TrilinosWrappers
        * performance, we keep a shared pointer to these entries so that more
        * than one accessor can access this data if necessary.
        */
-      std_cxx1x::shared_ptr<std::vector<size_type> > colnum_cache;
+      std_cxx11::shared_ptr<std::vector<size_type> > colnum_cache;
 
       /**
        * Cache for the values of this row.
        */
-      std_cxx1x::shared_ptr<std::vector<TrilinosScalar> > value_cache;
+      std_cxx11::shared_ptr<std::vector<TrilinosScalar> > value_cache;
     };
 
     /**
@@ -1848,26 +1848,26 @@ namespace TrilinosWrappers
      * Pointer to the user-supplied Epetra Trilinos mapping of the matrix
      * columns that assigns parts of the matrix to the individual processes.
      */
-    std_cxx1x::shared_ptr<Epetra_Map> column_space_map;
+    std_cxx11::shared_ptr<Epetra_Map> column_space_map;
 
     /**
      * A sparse matrix object in Trilinos to be used for finite element based
      * problems which allows for assembling into non-local elements.  The
      * actual type, a sparse matrix, is set in the constructor.
      */
-    std_cxx1x::shared_ptr<Epetra_FECrsMatrix> matrix;
+    std_cxx11::shared_ptr<Epetra_FECrsMatrix> matrix;
 
     /**
      * A sparse matrix object in Trilinos to be used for collecting the
      * non-local elements if the matrix was constructed from a Trilinos
      * sparsity pattern with the respective option.
      */
-    std_cxx1x::shared_ptr<Epetra_CrsMatrix> nonlocal_matrix;
+    std_cxx11::shared_ptr<Epetra_CrsMatrix> nonlocal_matrix;
 
     /**
      * An export object used to communicate the nonlocal matrix.
      */
-    std_cxx1x::shared_ptr<Epetra_Export>    nonlocal_matrix_exporter;
+    std_cxx11::shared_ptr<Epetra_Export>    nonlocal_matrix_exporter;
 
     /**
      * Trilinos doesn't allow to mix additions to matrix entries and
index 355aa2131ceebd8f0ea4f07e88f4cca42152b842..d722c5e8446c53c74254e8f19a1318294567bb85 100644 (file)
@@ -30,7 +30,7 @@
 #  include <cmath>
 #  include <memory>
 
-#  include <deal.II/base/std_cxx1x/shared_ptr.h>
+#  include <deal.II/base/std_cxx11/shared_ptr.h>
 
 #  include <Epetra_FECrsGraph.h>
 #  include <Epetra_Map.h>
@@ -150,7 +150,7 @@ namespace TrilinosWrappers
        * performance, we keep a shared pointer to these entries so that more
        * than one accessor can access this data if necessary.
        */
-      std_cxx1x::shared_ptr<const std::vector<size_type> > colnum_cache;
+      std_cxx11::shared_ptr<const std::vector<size_type> > colnum_cache;
 
       /**
        * Discard the old row caches (they may still be used by other
@@ -1092,20 +1092,20 @@ namespace TrilinosWrappers
      * Pointer to the user-supplied Epetra Trilinos mapping of the matrix
      * columns that assigns parts of the matrix to the individual processes.
      */
-    std_cxx1x::shared_ptr<Epetra_Map> column_space_map;
+    std_cxx11::shared_ptr<Epetra_Map> column_space_map;
 
     /**
      * A sparsity pattern object in Trilinos to be used for finite element
      * based problems which allows for adding non-local elements to the
      * pattern.
      */
-    std_cxx1x::shared_ptr<Epetra_FECrsGraph> graph;
+    std_cxx11::shared_ptr<Epetra_FECrsGraph> graph;
 
     /**
      * A sparsity pattern object for the non-local part of the sparsity
      * pattern that is going to be sent to the owning processor. Only used when the particular constructor or reinit method with writable_rows argument is set
      */
-    std_cxx1x::shared_ptr<Epetra_CrsGraph> nonlocal_graph;
+    std_cxx11::shared_ptr<Epetra_CrsGraph> nonlocal_graph;
 
     friend class SparseMatrix;
     friend class SparsityPatternIterators::Accessor;
index 951d660755dd7a7d8532e14002cac6ae85fb3130..d130582772e823dba0258051e43bdd48fee7ab2b 100644 (file)
@@ -22,7 +22,7 @@
 
 #ifdef DEAL_II_WITH_TRILINOS
 
-#  include <deal.II/base/std_cxx1x/shared_ptr.h>
+#  include <deal.II/base/std_cxx11/shared_ptr.h>
 #  include <deal.II/base/subscriptor.h>
 #  include <deal.II/base/index_set.h>
 #  include <deal.II/base/utilities.h>
index 27e3ffdab77cee06d24f34f3a95144915d8c7350..267254275b50d6b219b31ffbb156a45c2d3b215f 100644 (file)
@@ -23,7 +23,7 @@
 #ifdef DEAL_II_WITH_TRILINOS
 
 #include <deal.II/base/utilities.h>
-#  include <deal.II/base/std_cxx1x/shared_ptr.h>
+#  include <deal.II/base/std_cxx11/shared_ptr.h>
 #  include <deal.II/base/subscriptor.h>
 #  include <deal.II/lac/exceptions.h>
 #  include <deal.II/lac/vector.h>
@@ -898,14 +898,14 @@ namespace TrilinosWrappers
      * object requires an existing Epetra_Map for
      * storing data when setting it up.
      */
-    std_cxx1x::shared_ptr<Epetra_FEVector> vector;
+    std_cxx11::shared_ptr<Epetra_FEVector> vector;
 
     /**
      * A vector object in Trilinos to be used for collecting the non-local
      * elements if the vector was constructed with an additional IndexSet
      * describing ghost elements.
      */
-    std_cxx1x::shared_ptr<Epetra_MultiVector> nonlocal_vector;
+    std_cxx11::shared_ptr<Epetra_MultiVector> nonlocal_vector;
 
     /**
      * Make the reference class a friend.
index f7a21e851e896d6519e117dcb114a279efbc781d..f056e6acd546a0a14968bf8d85534b404cc0968c 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 1999 - 2013 by the deal.II authors
+// Copyright (C) 1999 - 2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -707,12 +707,12 @@ namespace internal
         dst.reinit (vec_size, true);
       if (vec_size>internal::Vector::minimum_parallel_grain_size)
         parallel::apply_to_subranges (0U, vec_size,
-                                      std_cxx1x::bind(&internal::Vector::template
+                                      std_cxx11::bind(&internal::Vector::template
                                                       copy_subrange <T,U>,
-                                                      std_cxx1x::_1,
-                                                      std_cxx1x::_2,
-                                                      std_cxx1x::cref(src),
-                                                      std_cxx1x::ref(dst)),
+                                                      std_cxx11::_1,
+                                                      std_cxx11::_2,
+                                                      std_cxx11::cref(src),
+                                                      std_cxx11::ref(dst)),
                                       internal::Vector::minimum_parallel_grain_size);
       else if (vec_size > 0)
         copy_subrange (0U, vec_size, src, dst);
@@ -731,9 +731,9 @@ Vector<Number>::operator = (const Number s)
     Assert (vec_size!=0, ExcEmptyObject());
   if (vec_size>internal::Vector::minimum_parallel_grain_size)
     parallel::apply_to_subranges (0U, vec_size,
-                                  std_cxx1x::bind(&internal::Vector::template
+                                  std_cxx11::bind(&internal::Vector::template
                                                   set_subrange<Number>,
-                                                  s, std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::ref(*this)),
+                                                  s, std_cxx11::_1, std_cxx11::_2, std_cxx11::ref(*this)),
                                   internal::Vector::minimum_parallel_grain_size);
   else if (vec_size > 0)
     internal::Vector::set_subrange<Number>(s, 0U, vec_size, *this);
index 6fdc4f49282b9808916e46d322cd4ac472b1bceb..9ea4a9266ad7ef6f4efee89de72121f9b3bb7514 100644 (file)
@@ -26,7 +26,7 @@
 #include <deal.II/dofs/dof_handler.h>
 #include <deal.II/matrix_free/helper_functions.h>
 
-#include <deal.II/base/std_cxx1x/array.h>
+#include <deal.II/base/std_cxx11/array.h>
 
 #include <memory>
 
@@ -305,7 +305,7 @@ namespace internal
        * certain structure in the indices, like indices for vector-valued
        * problems or for cells where not all vector components are filled.
        */
-      std::vector<std_cxx1x::array<unsigned int, 3> > row_starts;
+      std::vector<std_cxx11::array<unsigned int, 3> > row_starts;
 
       /**
        * Stores the indices of the degrees of freedom for each cell. These
@@ -342,7 +342,7 @@ namespace internal
        * in the vector, and also includes how the ghosts look like. This
        * enables initialization of vectors based on the DoFInfo field.
        */
-      std_cxx1x::shared_ptr<const Utilities::MPI::Partitioner> vector_partitioner;
+      std_cxx11::shared_ptr<const Utilities::MPI::Partitioner> vector_partitioner;
 
       /**
        * This stores a (sorted) list of all locally owned degrees of freedom
index b2e737ca11c036889c1ae6f6ebf87b14352d4169..702fc65f289df95e8968bc31393c61619cb420f5 100644 (file)
@@ -609,7 +609,7 @@ no_constraint:
           std::swap (new_active_fe_index, cell_active_fe_index);
         }
 
-      std::vector<std_cxx1x::array<unsigned int, 3> > new_row_starts;
+      std::vector<std_cxx11::array<unsigned int, 3> > new_row_starts;
       std::vector<unsigned int> new_dof_indices;
       std::vector<std::pair<unsigned short,unsigned short> >
       new_constraint_indicator;
@@ -1924,7 +1924,7 @@ not_connect:
     DoFInfo::memory_consumption () const
     {
       std::size_t memory = sizeof(*this);
-      memory += (row_starts.capacity()*sizeof(std_cxx1x::array<unsigned int,3>));
+      memory += (row_starts.capacity()*sizeof(std_cxx11::array<unsigned int,3>));
       memory += MemoryConsumption::memory_consumption (dof_indices);
       memory += MemoryConsumption::memory_consumption (row_starts_plain_indices);
       memory += MemoryConsumption::memory_consumption (plain_dof_indices);
@@ -1942,7 +1942,7 @@ not_connect:
     {
       out << "       Memory row starts indices:    ";
       size_info.print_memory_statistics
-      (out, (row_starts.capacity()*sizeof(std_cxx1x::array<unsigned int, 3>)));
+      (out, (row_starts.capacity()*sizeof(std_cxx11::array<unsigned int, 3>)));
       out << "       Memory dof indices:           ";
       size_info.print_memory_statistics
       (out, MemoryConsumption::memory_consumption (dof_indices));
index 0cb1c0e0ae1196f6bcae016291252d9db79e4eb4..5e6373465f63daad1bee7b93824621eb0359f5ff 100644 (file)
@@ -692,7 +692,7 @@ protected:
    * In case the class is initialized from MappingFEEvaluation instead of
    * MatrixFree, this data structure holds the evaluated shape data.
    */
-  std_cxx1x::shared_ptr<internal::MatrixFreeFunctions::ShapeInfo<Number> > stored_shape_info;
+  std_cxx11::shared_ptr<internal::MatrixFreeFunctions::ShapeInfo<Number> > stored_shape_info;
 
   /**
    * Stores a pointer to the unit cell shape data, i.e., values, gradients and
index f93060e5b782e1e91fcde50aefc9e61e1a8d15ff..09171dbcb0b51641347dc3c71144cec259c1e06c 100644 (file)
@@ -241,7 +241,7 @@ namespace internal
           // hp::DoFHandler<dim>::active_cell_iterator, we need to manually
           // select the correct finite element, so just hold a vector of
           // FEValues
-          std::vector<std_cxx1x::shared_ptr<FEValues<dim> > >
+          std::vector<std_cxx11::shared_ptr<FEValues<dim> > >
           fe_values (current_data.quadrature.size());
           UpdateFlags update_flags_feval =
             (update_flags & update_inverse_jacobians ? update_jacobians : update_default) |
index b7cbb6a017980e4842c97be4660b76df866f27bf..4220406ba3656bdc7b502e864d30335d7efb0ac1 100644 (file)
@@ -438,7 +438,7 @@ public:
    * to the function object.
    */
   template <typename OutVector, typename InVector>
-  void cell_loop (const std_cxx1x::function<void (const MatrixFree<dim,Number> &,
+  void cell_loop (const std_cxx11::function<void (const MatrixFree<dim,Number> &,
                                                   OutVector &,
                                                   const InVector &,
                                                   const std::pair<unsigned int,
@@ -451,7 +451,7 @@ public:
    * a function pointer to a member function of class @p CLASS with the
    * signature <code>cell_operation (const MatrixFree<dim,Number> &, OutVector
    * &, InVector &, std::pair<unsigned int,unsigned int>&)const</code>. This
-   * method obviates the need to call std_cxx1x::bind to bind the class into
+   * method obviates the need to call std_cxx11::bind to bind the class into
    * the given function in case the local function needs to access data in the
    * class (i.e., it is a non-static member function).
    */
@@ -541,7 +541,7 @@ public:
    * usually prefer this data structure as the data exchange information can
    * be reused from one vector to another.
    */
-  const std_cxx1x::shared_ptr<const Utilities::MPI::Partitioner> &
+  const std_cxx11::shared_ptr<const Utilities::MPI::Partitioner> &
   get_vector_partitioner (const unsigned int vector_component=0) const;
 
   /**
@@ -968,7 +968,7 @@ MatrixFree<dim,Number>::initialize_dof_vector(parallel::distributed::Vector<Numb
 
 template <int dim, typename Number>
 inline
-const std_cxx1x::shared_ptr<const Utilities::MPI::Partitioner> &
+const std_cxx11::shared_ptr<const Utilities::MPI::Partitioner> &
 MatrixFree<dim,Number>::get_vector_partitioner (const unsigned int comp) const
 {
   AssertIndexRange (comp, n_components());
@@ -2231,7 +2231,7 @@ template <typename OutVector, typename InVector>
 inline
 void
 MatrixFree<dim, Number>::cell_loop
-(const std_cxx1x::function<void (const MatrixFree<dim,Number> &,
+(const std_cxx11::function<void (const MatrixFree<dim,Number> &,
                                  OutVector &,
                                  const InVector &,
                                  const std::pair<unsigned int,
@@ -2251,14 +2251,14 @@ MatrixFree<dim, Number>::cell_loop
       // to simplify the function calls, bind away all arguments except the
       // cell range
       typedef
-      std_cxx1x::function<void (const std::pair<unsigned int,unsigned int> &range)>
+      std_cxx11::function<void (const std::pair<unsigned int,unsigned int> &range)>
       Worker;
 
-      const Worker func = std_cxx1x::bind (std_cxx1x::ref(cell_operation),
-                                           std_cxx1x::cref(*this),
-                                           std_cxx1x::ref(dst),
-                                           std_cxx1x::cref(src),
-                                           std_cxx1x::_1);
+      const Worker func = std_cxx11::bind (std_cxx11::ref(cell_operation),
+                                           std_cxx11::cref(*this),
+                                           std_cxx11::ref(dst),
+                                           std_cxx11::cref(src),
+                                           std_cxx11::_1);
 
       if (task_info.use_partition_partition == true)
         {
@@ -2521,19 +2521,19 @@ MatrixFree<dim,Number>::cell_loop
  OutVector      &dst,
  const InVector &src) const
 {
-  // here, use std_cxx1x::bind to hand a function handler with the appropriate
+  // here, use std_cxx11::bind to hand a function handler with the appropriate
   // argument to the other loop function
-  std_cxx1x::function<void (const MatrixFree<dim,Number> &,
+  std_cxx11::function<void (const MatrixFree<dim,Number> &,
                             OutVector &,
                             const InVector &,
                             const std::pair<unsigned int,
                             unsigned int> &)>
-  function = std_cxx1x::bind<void>(function_pointer,
-                                   std_cxx1x::cref(*owning_class),
-                                   std_cxx1x::_1,
-                                   std_cxx1x::_2,
-                                   std_cxx1x::_3,
-                                   std_cxx1x::_4);
+  function = std_cxx11::bind<void>(function_pointer,
+                                   std_cxx11::cref(*owning_class),
+                                   std_cxx11::_1,
+                                   std_cxx11::_2,
+                                   std_cxx11::_3,
+                                   std_cxx11::_4);
   cell_loop (function, dst, src);
 }
 
@@ -2553,19 +2553,19 @@ MatrixFree<dim,Number>::cell_loop
  OutVector      &dst,
  const InVector &src) const
 {
-  // here, use std_cxx1x::bind to hand a function handler with the appropriate
+  // here, use std_cxx11::bind to hand a function handler with the appropriate
   // argument to the other loop function
-  std_cxx1x::function<void (const MatrixFree<dim,Number> &,
+  std_cxx11::function<void (const MatrixFree<dim,Number> &,
                             OutVector &,
                             const InVector &,
                             const std::pair<unsigned int,
                             unsigned int> &)>
-  function = std_cxx1x::bind<void>(function_pointer,
-                                   std_cxx1x::ref(*owning_class),
-                                   std_cxx1x::_1,
-                                   std_cxx1x::_2,
-                                   std_cxx1x::_3,
-                                   std_cxx1x::_4);
+  function = std_cxx11::bind<void>(function_pointer,
+                                   std_cxx11::ref(*owning_class),
+                                   std_cxx11::_1,
+                                   std_cxx11::_2,
+                                   std_cxx11::_3,
+                                   std_cxx11::_4);
   cell_loop (function, dst, src);
 }
 
index 83b43b83dfdea94d0a08c7717976a3f3eca9b24b..b345de0806c0d447d9cc0ec0e187ca28fd83237a 100644 (file)
@@ -20,7 +20,7 @@
 
 #include <deal.II/base/config.h>
 #include <deal.II/base/quadrature_lib.h>
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 #include <deal.II/dofs/block_info.h>
 #include <deal.II/fe/fe_values.h>
 #include <deal.II/meshworker/local_results.h>
index f28b162dfbb3783097f77f5ef33387f57c0f7ab4..00178b2526d97147f556aae7df2ef5d9a5779a4a 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2006 - 2013 by the deal.II authors
+// Copyright (C) 2006 - 2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -20,7 +20,7 @@
 
 #include <deal.II/base/config.h>
 #include <deal.II/base/quadrature_lib.h>
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 #include <deal.II/dofs/block_info.h>
 #include <deal.II/fe/fe_values.h>
 #include <deal.II/meshworker/local_results.h>
@@ -79,7 +79,7 @@ namespace MeshWorker
   {
   private:
     /// vector of FEValues objects
-    std::vector<std_cxx1x::shared_ptr<FEValuesBase<dim, spacedim> > > fevalv;
+    std::vector<std_cxx11::shared_ptr<FEValuesBase<dim, spacedim> > > fevalv;
   public:
     static const unsigned int dimension = dim;
     static const unsigned int space_dimension = spacedim;
@@ -125,7 +125,7 @@ namespace MeshWorker
     /**
      * Initialize the data vector and cache the selector.
      */
-    void initialize_data(const std_cxx1x::shared_ptr<VectorDataBase<dim,spacedim> > &data);
+    void initialize_data(const std_cxx11::shared_ptr<VectorDataBase<dim,spacedim> > &data);
 
     /**
      * Delete the data created by initialize().
@@ -202,7 +202,7 @@ namespace MeshWorker
      * The global data vector used to compute function values in
      * quadrature points.
      */
-    std_cxx1x::shared_ptr<VectorDataBase<dim, spacedim> > global_data;
+    std_cxx11::shared_ptr<VectorDataBase<dim, spacedim> > global_data;
 
     /**
      * The memory used by this object.
@@ -490,9 +490,9 @@ namespace MeshWorker
      */
     MeshWorker::VectorSelector face_selector;
 
-    std_cxx1x::shared_ptr<MeshWorker::VectorDataBase<dim, spacedim> > cell_data;
-    std_cxx1x::shared_ptr<MeshWorker::VectorDataBase<dim, spacedim> > boundary_data;
-    std_cxx1x::shared_ptr<MeshWorker::VectorDataBase<dim, spacedim> > face_data;
+    std_cxx11::shared_ptr<MeshWorker::VectorDataBase<dim, spacedim> > cell_data;
+    std_cxx11::shared_ptr<MeshWorker::VectorDataBase<dim, spacedim> > boundary_data;
+    std_cxx11::shared_ptr<MeshWorker::VectorDataBase<dim, spacedim> > face_data;
     /* @} */
 
     /**
@@ -575,7 +575,7 @@ namespace MeshWorker
     :
     fevalv(0),
     multigrid(false),
-    global_data(std_cxx1x::shared_ptr<VectorDataBase<dim, sdim> >(new VectorDataBase<dim, sdim>))
+    global_data(std_cxx11::shared_ptr<VectorDataBase<dim, sdim> >(new VectorDataBase<dim, sdim>))
   {}
 
 
@@ -600,14 +600,14 @@ namespace MeshWorker
         const FESubfaceValues<dim,sdim> *ps = dynamic_cast<const FESubfaceValues<dim,sdim>*>(&p);
 
         if (pc != 0)
-          fevalv[i] = std_cxx1x::shared_ptr<FEValuesBase<dim,sdim> > (
+          fevalv[i] = std_cxx11::shared_ptr<FEValuesBase<dim,sdim> > (
                         new FEValues<dim,sdim> (pc->get_mapping(), pc->get_fe(),
                                                 pc->get_quadrature(), pc->get_update_flags()));
         else if (pf != 0)
-          fevalv[i] = std_cxx1x::shared_ptr<FEValuesBase<dim,sdim> > (
+          fevalv[i] = std_cxx11::shared_ptr<FEValuesBase<dim,sdim> > (
                         new FEFaceValues<dim,sdim> (pf->get_mapping(), pf->get_fe(), pf->get_quadrature(), pf->get_update_flags()));
         else if (ps != 0)
-          fevalv[i] = std_cxx1x::shared_ptr<FEValuesBase<dim,sdim> > (
+          fevalv[i] = std_cxx11::shared_ptr<FEValuesBase<dim,sdim> > (
                         new FESubfaceValues<dim,sdim> (ps->get_mapping(), ps->get_fe(), ps->get_quadrature(), ps->get_update_flags()));
         else
           Assert(false, ExcInternalError());
@@ -630,7 +630,7 @@ namespace MeshWorker
     if (block_info == 0 || block_info->local().size() == 0)
       {
         fevalv.resize(1);
-        fevalv[0] = std_cxx1x::shared_ptr<FEValuesBase<dim,sdim> > (
+        fevalv[0] = std_cxx11::shared_ptr<FEValuesBase<dim,sdim> > (
                       new FEVALUES (mapping, el, quadrature, flags));
       }
     else
@@ -638,7 +638,7 @@ namespace MeshWorker
         fevalv.resize(el.n_base_elements());
         for (unsigned int i=0; i<fevalv.size(); ++i)
           {
-            fevalv[i] = std_cxx1x::shared_ptr<FEValuesBase<dim,sdim> > (
+            fevalv[i] = std_cxx11::shared_ptr<FEValuesBase<dim,sdim> > (
                           new FEVALUES (mapping, el.base_element(i), quadrature, flags));
           }
       }
@@ -802,10 +802,10 @@ namespace MeshWorker
     const BlockInfo *block_info)
   {
     initialize(el, mapping, block_info);
-    std_cxx1x::shared_ptr<VectorData<VECTOR, dim, sdim> > p;
+    std_cxx11::shared_ptr<VectorData<VECTOR, dim, sdim> > p;
     VectorDataBase<dim,sdim> *pp;
 
-    p = std_cxx1x::shared_ptr<VectorData<VECTOR, dim, sdim> >(new VectorData<VECTOR, dim, sdim> (cell_selector));
+    p = std_cxx11::shared_ptr<VectorData<VECTOR, dim, sdim> >(new VectorData<VECTOR, dim, sdim> (cell_selector));
     // Public member function of parent class was not found without
     // explicit cast
     pp = &*p;
@@ -813,13 +813,13 @@ namespace MeshWorker
     cell_data = p;
     cell.initialize_data(p);
 
-    p = std_cxx1x::shared_ptr<VectorData<VECTOR, dim, sdim> >(new VectorData<VECTOR, dim, sdim> (boundary_selector));
+    p = std_cxx11::shared_ptr<VectorData<VECTOR, dim, sdim> >(new VectorData<VECTOR, dim, sdim> (boundary_selector));
     pp = &*p;
     pp->initialize(data);
     boundary_data = p;
     boundary.initialize_data(p);
 
-    p = std_cxx1x::shared_ptr<VectorData<VECTOR, dim, sdim> >(new VectorData<VECTOR, dim, sdim> (face_selector));
+    p = std_cxx11::shared_ptr<VectorData<VECTOR, dim, sdim> >(new VectorData<VECTOR, dim, sdim> (face_selector));
     pp = &*p;
     pp->initialize(data);
     face_data = p;
@@ -839,19 +839,19 @@ namespace MeshWorker
     const BlockInfo *block_info)
   {
     initialize(el, mapping, block_info);
-    std_cxx1x::shared_ptr<VectorData<VECTOR, dim, sdim> > p;
+    std_cxx11::shared_ptr<VectorData<VECTOR, dim, sdim> > p;
 
-    p = std_cxx1x::shared_ptr<VectorData<VECTOR, dim, sdim> >(new VectorData<VECTOR, dim, sdim> (cell_selector));
+    p = std_cxx11::shared_ptr<VectorData<VECTOR, dim, sdim> >(new VectorData<VECTOR, dim, sdim> (cell_selector));
     p->initialize(data);
     cell_data = p;
     cell.initialize_data(p);
 
-    p = std_cxx1x::shared_ptr<VectorData<VECTOR, dim, sdim> >(new VectorData<VECTOR, dim, sdim> (boundary_selector));
+    p = std_cxx11::shared_ptr<VectorData<VECTOR, dim, sdim> >(new VectorData<VECTOR, dim, sdim> (boundary_selector));
     p->initialize(data);
     boundary_data = p;
     boundary.initialize_data(p);
 
-    p = std_cxx1x::shared_ptr<VectorData<VECTOR, dim, sdim> >(new VectorData<VECTOR, dim, sdim> (face_selector));
+    p = std_cxx11::shared_ptr<VectorData<VECTOR, dim, sdim> >(new VectorData<VECTOR, dim, sdim> (face_selector));
     p->initialize(data);
     face_data = p;
     face.initialize_data(p);
@@ -870,19 +870,19 @@ namespace MeshWorker
     const BlockInfo *block_info)
   {
     initialize(el, mapping, block_info);
-    std_cxx1x::shared_ptr<MGVectorData<VECTOR, dim, sdim> > p;
+    std_cxx11::shared_ptr<MGVectorData<VECTOR, dim, sdim> > p;
 
-    p = std_cxx1x::shared_ptr<MGVectorData<VECTOR, dim, sdim> >(new MGVectorData<VECTOR, dim, sdim> (cell_selector));
+    p = std_cxx11::shared_ptr<MGVectorData<VECTOR, dim, sdim> >(new MGVectorData<VECTOR, dim, sdim> (cell_selector));
     p->initialize(data);
     cell_data = p;
     cell.initialize_data(p);
 
-    p = std_cxx1x::shared_ptr<MGVectorData<VECTOR, dim, sdim> >(new MGVectorData<VECTOR, dim, sdim> (boundary_selector));
+    p = std_cxx11::shared_ptr<MGVectorData<VECTOR, dim, sdim> >(new MGVectorData<VECTOR, dim, sdim> (boundary_selector));
     p->initialize(data);
     boundary_data = p;
     boundary.initialize_data(p);
 
-    p = std_cxx1x::shared_ptr<MGVectorData<VECTOR, dim, sdim> >(new MGVectorData<VECTOR, dim, sdim> (face_selector));
+    p = std_cxx11::shared_ptr<MGVectorData<VECTOR, dim, sdim> >(new MGVectorData<VECTOR, dim, sdim> (face_selector));
     p->initialize(data);
     face_data = p;
     face.initialize_data(p);
index b1e1c21932a1e9d9e9aabe47d840a1d1f74dd718..3acaa1529937dfca53034fd93f216b635f7ce069 100644 (file)
@@ -26,7 +26,7 @@ namespace MeshWorker
   template<int dim, int sdim>
   void
   IntegrationInfo<dim,sdim>::initialize_data(
-    const std_cxx1x::shared_ptr<VectorDataBase<dim,sdim> > &data)
+    const std_cxx11::shared_ptr<VectorDataBase<dim,sdim> > &data)
   {
     global_data = data;
     const unsigned int nqp = fevalv[0]->n_quadrature_points;
index b59cba7d2eeee84548c2d464dd4f957646cc42cb..df17280466caa95196d71922e75d7e747123a5d1 100644 (file)
@@ -20,7 +20,7 @@
 
 #include <deal.II/base/config.h>
 #include <deal.II/base/subscriptor.h>
-#include <deal.II/base/std_cxx1x/function.h>
+#include <deal.II/base/std_cxx11/function.h>
 
 #include <vector>
 #include <string>
index 828632548a3d1d5c126fb19bbeb474dd5d0dd481..036d7c70739a7c8358b1932fc3d4779819b797ac 100644 (file)
@@ -19,7 +19,7 @@
 #define __deal2__mesh_worker_local_results_h
 
 #include <deal.II/base/config.h>
-#include <deal.II/base/std_cxx1x/function.h>
+#include <deal.II/base/std_cxx11/function.h>
 #include <deal.II/base/geometry_info.h>
 #include <deal.II/lac/matrix_block.h>
 #include <deal.II/lac/block_vector.h>
index 0bc20f0cd27cba1fa86a3f5a32f8762b34b91a39..5e28d04e373a27e24044f1dae39875586be61b7b 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2006 - 2013 by the deal.II authors
+// Copyright (C) 2006 - 2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -19,7 +19,7 @@
 #define __deal2__mesh_worker_loop_h
 
 #include <deal.II/base/config.h>
-#include <deal.II/base/std_cxx1x/function.h>
+#include <deal.II/base/std_cxx11/function.h>
 #include <deal.II/base/work_stream.h>
 #include <deal.II/base/template_constraints.h>
 #include <deal.II/grid/tria.h>
@@ -167,9 +167,9 @@ namespace MeshWorker
     ITERATOR cell,
     DoFInfoBox<dim, DOFINFO> &dof_info,
     INFOBOX &info,
-    const std_cxx1x::function<void (DOFINFO &, typename INFOBOX::CellInfo &)> &cell_worker,
-    const std_cxx1x::function<void (DOFINFO &, typename INFOBOX::CellInfo &)> &boundary_worker,
-    const std_cxx1x::function<void (DOFINFO &, DOFINFO &,
+    const std_cxx11::function<void (DOFINFO &, typename INFOBOX::CellInfo &)> &cell_worker,
+    const std_cxx11::function<void (DOFINFO &, typename INFOBOX::CellInfo &)> &boundary_worker,
+    const std_cxx11::function<void (DOFINFO &, DOFINFO &,
                                     typename INFOBOX::CellInfo &,
                                     typename INFOBOX::CellInfo &)> &face_worker,
     const LoopControl &loop_control)
@@ -377,9 +377,9 @@ namespace MeshWorker
             typename identity<ITERATOR>::type end,
             DOFINFO &dinfo,
             INFOBOX &info,
-            const std_cxx1x::function<void (DOFINFO &, typename INFOBOX::CellInfo &)> &cell_worker,
-            const std_cxx1x::function<void (DOFINFO &, typename INFOBOX::CellInfo &)> &boundary_worker,
-            const std_cxx1x::function<void (DOFINFO &, DOFINFO &,
+            const std_cxx11::function<void (DOFINFO &, typename INFOBOX::CellInfo &)> &cell_worker,
+            const std_cxx11::function<void (DOFINFO &, typename INFOBOX::CellInfo &)> &boundary_worker,
+            const std_cxx11::function<void (DOFINFO &, DOFINFO &,
                                             typename INFOBOX::CellInfo &,
                                             typename INFOBOX::CellInfo &)> &face_worker,
             ASSEMBLER &assembler,
@@ -397,10 +397,10 @@ namespace MeshWorker
     // Loop over all cells
 #ifdef DEAL_II_MESHWORKER_PARALLEL
     WorkStream::run(begin, end,
-                    std_cxx1x::bind(&cell_action<INFOBOX, DOFINFO, dim, spacedim, ITERATOR>,
-                                    std_cxx1x::_1, std_cxx1x::_3, std_cxx1x::_2,
+                    std_cxx11::bind(&cell_action<INFOBOX, DOFINFO, dim, spacedim, ITERATOR>,
+                                    std_cxx11::_1, std_cxx11::_3, std_cxx11::_2,
                                     cell_worker, boundary_worker, face_worker, lctrl),
-                    std_cxx1x::bind(&internal::assemble<dim,DOFINFO,ASSEMBLER>, std_cxx1x::_1, &assembler),
+                    std_cxx11::bind(&internal::assemble<dim,DOFINFO,ASSEMBLER>, std_cxx11::_1, &assembler),
                     info, dof_info);
 #else
     for (ITERATOR cell = begin; cell != end; ++cell)
@@ -419,9 +419,9 @@ namespace MeshWorker
             typename identity<ITERATOR>::type end,
             DOFINFO &dinfo,
             INFOBOX &info,
-            const std_cxx1x::function<void (DOFINFO &, typename INFOBOX::CellInfo &)> &cell_worker,
-            const std_cxx1x::function<void (DOFINFO &, typename INFOBOX::CellInfo &)> &boundary_worker,
-            const std_cxx1x::function<void (DOFINFO &, DOFINFO &,
+            const std_cxx11::function<void (DOFINFO &, typename INFOBOX::CellInfo &)> &cell_worker,
+            const std_cxx11::function<void (DOFINFO &, typename INFOBOX::CellInfo &)> &boundary_worker,
+            const std_cxx11::function<void (DOFINFO &, DOFINFO &,
                                             typename INFOBOX::CellInfo &,
                                             typename INFOBOX::CellInfo &)> &face_worker,
             ASSEMBLER &assembler,
@@ -433,9 +433,9 @@ namespace MeshWorker
             typename identity<ITERATOR>::type end,
             DOFINFO &dinfo,
             INFOBOX &info,
-            const std_cxx1x::function<void (DOFINFO &, typename INFOBOX::CellInfo &)> &cell_worker,
-            const std_cxx1x::function<void (DOFINFO &, typename INFOBOX::CellInfo &)> &boundary_worker,
-            const std_cxx1x::function<void (DOFINFO &, DOFINFO &,
+            const std_cxx11::function<void (DOFINFO &, typename INFOBOX::CellInfo &)> &cell_worker,
+            const std_cxx11::function<void (DOFINFO &, typename INFOBOX::CellInfo &)> &boundary_worker,
+            const std_cxx11::function<void (DOFINFO &, DOFINFO &,
                                             typename INFOBOX::CellInfo &,
                                             typename INFOBOX::CellInfo &)> &face_worker,
             ASSEMBLER &assembler,
@@ -465,9 +465,9 @@ namespace MeshWorker
                         typename identity<ITERATOR>::type end,
                         DoFInfo<dim, spacedim> &dof_info,
                         IntegrationInfoBox<dim, spacedim> &box,
-                        const std_cxx1x::function<void (DoFInfo<dim>&, IntegrationInfo<dim, spacedim>&)> &cell_worker,
-                        const std_cxx1x::function<void (DoFInfo<dim>&, IntegrationInfo<dim, spacedim>&)> &boundary_worker,
-                        const std_cxx1x::function<void (DoFInfo<dim> &, DoFInfo<dim> &,
+                        const std_cxx11::function<void (DoFInfo<dim>&, IntegrationInfo<dim, spacedim>&)> &cell_worker,
+                        const std_cxx11::function<void (DoFInfo<dim>&, IntegrationInfo<dim, spacedim>&)> &boundary_worker,
+                        const std_cxx11::function<void (DoFInfo<dim> &, DoFInfo<dim> &,
                                                         IntegrationInfo<dim, spacedim> &,
                                                         IntegrationInfo<dim, spacedim> &)> &face_worker,
                         ASSEMBLER &assembler,
@@ -479,9 +479,9 @@ namespace MeshWorker
                         typename identity<ITERATOR>::type end,
                         DoFInfo<dim, spacedim> &dof_info,
                         IntegrationInfoBox<dim, spacedim> &box,
-                        const std_cxx1x::function<void (DoFInfo<dim>&, IntegrationInfo<dim, spacedim>&)> &cell_worker,
-                        const std_cxx1x::function<void (DoFInfo<dim>&, IntegrationInfo<dim, spacedim>&)> &boundary_worker,
-                        const std_cxx1x::function<void (DoFInfo<dim> &, DoFInfo<dim> &,
+                        const std_cxx11::function<void (DoFInfo<dim>&, IntegrationInfo<dim, spacedim>&)> &cell_worker,
+                        const std_cxx11::function<void (DoFInfo<dim>&, IntegrationInfo<dim, spacedim>&)> &boundary_worker,
+                        const std_cxx11::function<void (DoFInfo<dim> &, DoFInfo<dim> &,
                                                         IntegrationInfo<dim, spacedim> &,
                                                         IntegrationInfo<dim, spacedim> &)> &face_worker,
                         ASSEMBLER &assembler,
@@ -528,17 +528,17 @@ namespace MeshWorker
                         ASSEMBLER &assembler,
                         bool cells_first)
   {
-    std_cxx1x::function<void (DoFInfo<dim>&, IntegrationInfo<dim, spacedim>&)> cell_worker;
-    std_cxx1x::function<void (DoFInfo<dim>&, IntegrationInfo<dim, spacedim>&)> boundary_worker;
-    std_cxx1x::function<void (DoFInfo<dim> &, DoFInfo<dim> &,
+    std_cxx11::function<void (DoFInfo<dim>&, IntegrationInfo<dim, spacedim>&)> cell_worker;
+    std_cxx11::function<void (DoFInfo<dim>&, IntegrationInfo<dim, spacedim>&)> boundary_worker;
+    std_cxx11::function<void (DoFInfo<dim> &, DoFInfo<dim> &,
                               IntegrationInfo<dim, spacedim> &,
                               IntegrationInfo<dim, spacedim> &)> face_worker;
     if (integrator.use_cell)
-      cell_worker = std_cxx1x::bind(&LocalIntegrator<dim, spacedim>::cell, &integrator, std_cxx1x::_1, std_cxx1x::_2);
+      cell_worker = std_cxx11::bind(&LocalIntegrator<dim, spacedim>::cell, &integrator, std_cxx11::_1, std_cxx11::_2);
     if (integrator.use_boundary)
-      boundary_worker = std_cxx1x::bind(&LocalIntegrator<dim, spacedim>::boundary, &integrator, std_cxx1x::_1, std_cxx1x::_2);
+      boundary_worker = std_cxx11::bind(&LocalIntegrator<dim, spacedim>::boundary, &integrator, std_cxx11::_1, std_cxx11::_2);
     if (integrator.use_face)
-      face_worker = std_cxx1x::bind(&LocalIntegrator<dim, spacedim>::face, &integrator, std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::_4);
+      face_worker = std_cxx11::bind(&LocalIntegrator<dim, spacedim>::face, &integrator, std_cxx11::_1, std_cxx11::_2, std_cxx11::_3, std_cxx11::_4);
 
     loop<dim, spacedim>
     (begin, end,
@@ -563,17 +563,17 @@ namespace MeshWorker
                         ASSEMBLER &assembler,
                         const LoopControl &lctrl = LoopControl())
   {
-    std_cxx1x::function<void (DoFInfo<dim>&, IntegrationInfo<dim, spacedim>&)> cell_worker;
-    std_cxx1x::function<void (DoFInfo<dim>&, IntegrationInfo<dim, spacedim>&)> boundary_worker;
-    std_cxx1x::function<void (DoFInfo<dim> &, DoFInfo<dim> &,
+    std_cxx11::function<void (DoFInfo<dim>&, IntegrationInfo<dim, spacedim>&)> cell_worker;
+    std_cxx11::function<void (DoFInfo<dim>&, IntegrationInfo<dim, spacedim>&)> boundary_worker;
+    std_cxx11::function<void (DoFInfo<dim> &, DoFInfo<dim> &,
                               IntegrationInfo<dim, spacedim> &,
                               IntegrationInfo<dim, spacedim> &)> face_worker;
     if (integrator.use_cell)
-      cell_worker = std_cxx1x::bind(&LocalIntegrator<dim, spacedim>::cell, &integrator, std_cxx1x::_1, std_cxx1x::_2);
+      cell_worker = std_cxx11::bind(&LocalIntegrator<dim, spacedim>::cell, &integrator, std_cxx11::_1, std_cxx11::_2);
     if (integrator.use_boundary)
-      boundary_worker = std_cxx1x::bind(&LocalIntegrator<dim, spacedim>::boundary, &integrator, std_cxx1x::_1, std_cxx1x::_2);
+      boundary_worker = std_cxx11::bind(&LocalIntegrator<dim, spacedim>::boundary, &integrator, std_cxx11::_1, std_cxx11::_2);
     if (integrator.use_face)
-      face_worker = std_cxx1x::bind(&LocalIntegrator<dim, spacedim>::face, &integrator, std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::_4);
+      face_worker = std_cxx11::bind(&LocalIntegrator<dim, spacedim>::face, &integrator, std_cxx11::_1, std_cxx11::_2, std_cxx11::_3, std_cxx11::_4);
 
     loop<dim, spacedim>
     (begin, end,
index ca7d17925cf0e3d5f218b8e2529d417334e24cce..f99fa086f0e9fc1ae0e024f227f3d95364e14e49 100644 (file)
@@ -22,7 +22,7 @@
 #include <deal.II/lac/sparse_matrix.h>
 #include <deal.II/multigrid/mg_base.h>
 #include <deal.II/base/mg_level_object.h>
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -83,7 +83,7 @@ namespace mg
      */
     std::size_t memory_consumption () const;
   private:
-    MGLevelObject<std_cxx1x::shared_ptr<PointerMatrixBase<VECTOR> > > matrices;
+    MGLevelObject<std_cxx11::shared_ptr<PointerMatrixBase<VECTOR> > > matrices;
   };
 
 }
@@ -223,7 +223,7 @@ namespace mg
   {
     matrices.resize(p.min_level(), p.max_level());
     for (unsigned int level=p.min_level(); level <= p.max_level(); ++level)
-      matrices[level] = std_cxx1x::shared_ptr<PointerMatrixBase<VECTOR> > (new_pointer_matrix_base(p[level], VECTOR()));
+      matrices[level] = std_cxx11::shared_ptr<PointerMatrixBase<VECTOR> > (new_pointer_matrix_base(p[level], VECTOR()));
   }
 
 
index 272f52740381a01eff8dcb40b9c5cc4aa6ffa577..c80432defd1a8f961e42b58c4365a784f9344a5c 100644 (file)
@@ -33,7 +33,7 @@
 
 #include <deal.II/dofs/dof_handler.h>
 
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 
 
 DEAL_II_NAMESPACE_OPEN
@@ -269,14 +269,14 @@ private:
   /**
    * Sparsity patterns for transfer matrices.
    */
-  std::vector<std_cxx1x::shared_ptr<typename internal::MatrixSelector<VECTOR>::Sparsity> >   prolongation_sparsities;
+  std::vector<std_cxx11::shared_ptr<typename internal::MatrixSelector<VECTOR>::Sparsity> >   prolongation_sparsities;
 
   /**
    * The actual prolongation matrix.  column indices belong to the dof
    * indices of the mother cell, i.e. the coarse level.  while row
    * indices belong to the child cell, i.e. the fine level.
    */
-  std::vector<std_cxx1x::shared_ptr<typename internal::MatrixSelector<VECTOR>::Matrix> > prolongation_matrices;
+  std::vector<std_cxx11::shared_ptr<typename internal::MatrixSelector<VECTOR>::Matrix> > prolongation_matrices;
 
   /**
    * Mapping for the copy_to_mg() and copy_from_mg() functions. Here only
index b06e47f4044c4ab130e11f9606035404e4a5d0ab..7623b1c08fad9e488aa1590709044d13b37c246d 100644 (file)
@@ -33,7 +33,7 @@
 
 #include <deal.II/dofs/dof_handler.h>
 
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 
 
 DEAL_II_NAMESPACE_OPEN
@@ -148,7 +148,7 @@ protected:
   DeclException0(ExcMatricesNotBuilt);
 
 private:
-  std::vector<std_cxx1x::shared_ptr<BlockSparsityPattern> >   prolongation_sparsities;
+  std::vector<std_cxx11::shared_ptr<BlockSparsityPattern> >   prolongation_sparsities;
 
 protected:
 
@@ -160,7 +160,7 @@ protected:
    * while row indices belong to the
    * child cell, i.e. the fine level.
    */
-  std::vector<std_cxx1x::shared_ptr<BlockSparseMatrix<double> > > prolongation_matrices;
+  std::vector<std_cxx11::shared_ptr<BlockSparseMatrix<double> > > prolongation_matrices;
 
   /**
    * Mapping for the
index 305c82853246c9ed47dbd7e099315dd3392977c5..518f196f9537391a20a7ccc4c244cddebbb5c942 100644 (file)
@@ -19,7 +19,7 @@
 
 #include <deal.II/base/config.h>
 
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 #include <deal.II/lac/block_vector.h>
 #include <deal.II/lac/constraint_matrix.h>
 #include <deal.II/lac/sparsity_pattern.h>
@@ -147,7 +147,7 @@ protected:
   DeclException0(ExcMatricesNotBuilt);
 
 private:
-  std::vector<std_cxx1x::shared_ptr<BlockSparsityPattern> >   prolongation_sparsities;
+  std::vector<std_cxx11::shared_ptr<BlockSparsityPattern> >   prolongation_sparsities;
 
 protected:
 
@@ -159,7 +159,7 @@ protected:
    * while row indices belong to the
    * child cell, i.e. the fine level.
    */
-  std::vector<std_cxx1x::shared_ptr<BlockSparseMatrix<double> > > prolongation_matrices;
+  std::vector<std_cxx11::shared_ptr<BlockSparseMatrix<double> > > prolongation_matrices;
 
   /**
    * Holds the mapping for the
index 5e128a2f392ec2d6d349360bbc7a9fb5b1420337..fca0ad3e2a8eafe5d556ada6bcfe08f7107291b9 100644 (file)
@@ -24,7 +24,7 @@
 #include <deal.II/multigrid/mg_base.h>
 #include <deal.II/multigrid/mg_tools.h>
 #include <deal.II/base/mg_level_object.h>
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 
 DEAL_II_NAMESPACE_OPEN
 
index adba6b9e95f1e69fcc5d74bd89eb3cd830e45056..a4bb73387a02ce4ee5603a19385086c25e6f1724 100644 (file)
@@ -22,7 +22,7 @@
 #include <deal.II/base/config.h>
 #include <deal.II/numerics/data_out_dof_data.h>
 
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -44,7 +44,7 @@ namespace internal
                     const unsigned int n_subdivisions,
                     const std::vector<unsigned int> &n_postprocessor_outputs,
                     const Mapping<dim,spacedim> &mapping,
-                    const std::vector<std_cxx1x::shared_ptr<dealii::hp::FECollection<dim,spacedim> > > &finite_elements,
+                    const std::vector<std_cxx11::shared_ptr<dealii::hp::FECollection<dim,spacedim> > > &finite_elements,
                     const UpdateFlags update_flags,
                     const std::vector<std::vector<unsigned int> > &cell_to_patch_index_map);
 
index fdc24dbd2fd1c085ec2fe88b33d8eff36caa87f2..25cf4f2e28105a68db6c95289c1a77e72f39742b 100644 (file)
@@ -32,7 +32,7 @@
 #include <deal.II/numerics/data_postprocessor.h>
 #include <deal.II/numerics/data_component_interpretation.h>
 
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -214,14 +214,14 @@ namespace internal
                         const unsigned int n_subdivisions,
                         const std::vector<unsigned int> &n_postprocessor_outputs,
                         const Mapping<dim,spacedim> &mapping,
-                        const std::vector<std_cxx1x::shared_ptr<dealii::hp::FECollection<dim,spacedim> > > &finite_elements,
+                        const std::vector<std_cxx11::shared_ptr<dealii::hp::FECollection<dim,spacedim> > > &finite_elements,
                         const UpdateFlags update_flags,
                         const bool        use_face_values);
 
       ParallelDataBase (const ParallelDataBase &data);
 
       template <typename DH>
-      void reinit_all_fe_values(std::vector<std_cxx1x::shared_ptr<DataEntryBase<DH> > > &dof_data,
+      void reinit_all_fe_values(std::vector<std_cxx11::shared_ptr<DataEntryBase<DH> > > &dof_data,
                                 const typename dealii::Triangulation<dim,spacedim>::cell_iterator &cell,
                                 const unsigned int face = numbers::invalid_unsigned_int);
 
@@ -242,11 +242,11 @@ namespace internal
       std::vector<std::vector<dealii::Vector<double> > > postprocessed_values;
 
       const dealii::hp::MappingCollection<dim,spacedim> mapping_collection;
-      const std::vector<std_cxx1x::shared_ptr<dealii::hp::FECollection<dim,spacedim> > > finite_elements;
+      const std::vector<std_cxx11::shared_ptr<dealii::hp::FECollection<dim,spacedim> > > finite_elements;
       const UpdateFlags update_flags;
 
-      std::vector<std_cxx1x::shared_ptr<dealii::hp::FEValues<dim,spacedim> > > x_fe_values;
-      std::vector<std_cxx1x::shared_ptr<dealii::hp::FEFaceValues<dim,spacedim> > > x_fe_face_values;
+      std::vector<std_cxx11::shared_ptr<dealii::hp::FEValues<dim,spacedim> > > x_fe_values;
+      std::vector<std_cxx11::shared_ptr<dealii::hp::FEFaceValues<dim,spacedim> > > x_fe_face_values;
     };
   }
 }
@@ -785,12 +785,12 @@ protected:
   /**
    * List of data elements with vectors of values for each degree of freedom.
    */
-  std::vector<std_cxx1x::shared_ptr<internal::DataOut::DataEntryBase<DH> > >  dof_data;
+  std::vector<std_cxx11::shared_ptr<internal::DataOut::DataEntryBase<DH> > >  dof_data;
 
   /**
    * List of data elements with vectors of values for each cell.
    */
-  std::vector<std_cxx1x::shared_ptr<internal::DataOut::DataEntryBase<DH> > >  cell_data;
+  std::vector<std_cxx11::shared_ptr<internal::DataOut::DataEntryBase<DH> > >  cell_data;
 
   /**
    * This is a list of patches that is created each time build_patches() is
@@ -817,7 +817,7 @@ protected:
    * Extracts the finite elements stored in the dof_data object, including a
    * dummy object of FE_DGQ<dim>(0) in case only the triangulation is used.
    */
-  std::vector<std_cxx1x::shared_ptr<dealii::hp::FECollection<DH::dimension,DH::space_dimension> > >
+  std::vector<std_cxx11::shared_ptr<dealii::hp::FECollection<DH::dimension,DH::space_dimension> > >
   get_finite_elements() const;
 
   /**
@@ -825,7 +825,7 @@ protected:
    * function. See there for a more extensive documentation.
    */
   virtual
-  std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> >
+  std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> >
   get_vector_data_ranges () const;
 
   /**
@@ -874,16 +874,16 @@ merge_patches (const DataOut_DoFData<DH2,patch_dim,patch_space_dim> &source,
                       "as vectors."));
   for (unsigned int i=0; i<get_vector_data_ranges().size(); ++i)
     {
-      Assert (std_cxx1x::get<0>(get_vector_data_ranges()[i]) ==
-              std_cxx1x::get<0>(source.get_vector_data_ranges()[i]),
+      Assert (std_cxx11::get<0>(get_vector_data_ranges()[i]) ==
+              std_cxx11::get<0>(source.get_vector_data_ranges()[i]),
               ExcMessage ("Both sources need to declare the same components "
                           "as vectors."));
-      Assert (std_cxx1x::get<1>(get_vector_data_ranges()[i]) ==
-              std_cxx1x::get<1>(source.get_vector_data_ranges()[i]),
+      Assert (std_cxx11::get<1>(get_vector_data_ranges()[i]) ==
+              std_cxx11::get<1>(source.get_vector_data_ranges()[i]),
               ExcMessage ("Both sources need to declare the same components "
                           "as vectors."));
-      Assert (std_cxx1x::get<2>(get_vector_data_ranges()[i]) ==
-              std_cxx1x::get<2>(source.get_vector_data_ranges()[i]),
+      Assert (std_cxx11::get<2>(get_vector_data_ranges()[i]) ==
+              std_cxx11::get<2>(source.get_vector_data_ranges()[i]),
               ExcMessage ("Both sources need to declare the same components "
                           "as vectors."));
     }
index 08d65d19271d377e05f20a2fa8b32f09a4a4a779..21ff8b6e01f7cecf48d6e227edf4a1251d18d308 100644 (file)
@@ -47,7 +47,7 @@ namespace internal
                     const unsigned int n_subdivisions,
                     const std::vector<unsigned int> &n_postprocessor_outputs,
                     const Mapping<dim,spacedim> &mapping,
-                    const std::vector<std_cxx1x::shared_ptr<dealii::hp::FECollection<dim,spacedim> > > &finite_elements,
+                    const std::vector<std_cxx11::shared_ptr<dealii::hp::FECollection<dim,spacedim> > > &finite_elements,
                     const UpdateFlags update_flags);
 
       std::vector<Point<dim> > patch_normals;
index 0099d6d8778f44a70c5e49b8db8323f7599e3b4f..9152953927e86fcad34a6ffb7026afea65a7887f 100644 (file)
@@ -48,7 +48,7 @@ namespace internal
                     const unsigned int n_patches_per_circle,
                     const std::vector<unsigned int> &n_postprocessor_outputs,
                     const Mapping<dim,spacedim> &mapping,
-                    const std::vector<std_cxx1x::shared_ptr<dealii::hp::FECollection<dim,spacedim> > > &finite_elements,
+                    const std::vector<std_cxx11::shared_ptr<dealii::hp::FECollection<dim,spacedim> > > &finite_elements,
                     const UpdateFlags update_flags);
 
       const unsigned int n_patches_per_circle;
index 4cff0bef05d3b2f1cebf52d8a69e84bb94e11551..e1e9f00a65fc746076f7da67d3ed776345fb4238 100644 (file)
@@ -19,7 +19,7 @@
 
 #include <deal.II/base/config.h>
 #include <deal.II/base/exceptions.h>
-#include <deal.II/base/std_cxx1x/tuple.h>
+#include <deal.II/base/std_cxx11/tuple.h>
 #include <deal.II/base/synchronous_iterator.h>
 #include <deal.II/fe/fe_update_flags.h>
 #include <deal.II/fe/mapping.h>
index efa2c2d9224688af5161679c7386210f14c56faa..3f732b26f6f80e125f6786cf35f181e2711e5c0c 100644 (file)
@@ -60,7 +60,7 @@
 #include <deal.II/numerics/vector_tools.h>
 #include <deal.II/numerics/matrix_tools.h>
 
-#include <deal.II/base/std_cxx1x/array.h>
+#include <deal.II/base/std_cxx11/array.h>
 #include <numeric>
 #include <algorithm>
 #include <vector>
@@ -4870,8 +4870,8 @@ namespace VectorTools
     template <int dim>
     struct PointComparator
     {
-      bool operator ()(const std_cxx1x::array<types::global_dof_index,dim> &p1,
-                       const std_cxx1x::array<types::global_dof_index,dim> &p2)
+      bool operator ()(const std_cxx11::array<types::global_dof_index,dim> &p1,
+                       const std_cxx11::array<types::global_dof_index,dim> &p2)
       {
         for (unsigned int d=0; d<dim; ++d)
           if (p1[d] < p2[d])
@@ -4952,14 +4952,14 @@ namespace VectorTools
     // Extract a list that collects all vector components that belong to the
     // same node (scalar basis function). When creating that list, we use an
     // array of dim components that stores the global degree of freedom.
-    std::set<std_cxx1x::array<types::global_dof_index,dim>, PointComparator<dim> > vector_dofs;
+    std::set<std_cxx11::array<types::global_dof_index,dim>, PointComparator<dim> > vector_dofs;
     std::vector<types::global_dof_index> face_dofs;
 
-    std::map<std_cxx1x::array<types::global_dof_index,dim>, Vector<double> >
+    std::map<std_cxx11::array<types::global_dof_index,dim>, Vector<double> >
     dof_vector_to_b_values;
 
     std::set<types::boundary_id>::iterator b_id;
-    std::vector<std_cxx1x::array<types::global_dof_index,dim> > cell_vector_dofs;
+    std::vector<std_cxx11::array<types::global_dof_index,dim> > cell_vector_dofs;
     for (typename DH<dim,spacedim>::active_cell_iterator cell =
            dof_handler.begin_active(); cell != dof_handler.end(); ++cell)
       if (!cell->is_artificial())
@@ -5024,7 +5024,7 @@ namespace VectorTools
     // iterate over the list of all vector components we found and see if we
     // can find constrained ones
     unsigned int n_total_constraints_found = 0;
-    for (typename std::set<std_cxx1x::array<types::global_dof_index,dim>,
+    for (typename std::set<std_cxx11::array<types::global_dof_index,dim>,
          PointComparator<dim> >::const_iterator it=vector_dofs.begin();
          it!=vector_dofs.end(); ++it)
       {
index ccbc597a239b5dbcc141dd246217b19aefa218fe..2a9cd045bec6a044b273fcfd38f7b4a90e1b7e4e 100644 (file)
@@ -37,7 +37,7 @@
 #include <deal.II/base/parameter_handler.h>
 #include <deal.II/base/thread_management.h>
 #include <deal.II/base/memory_consumption.h>
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 #include <deal.II/base/mpi.h>
 
 #include <cstring>
@@ -2950,7 +2950,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_ucd (const std::vector<Patch<dim,spacedim> > &patches,
                   const std::vector<std::string>          &data_names,
-                  const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &,
+                  const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &,
                   const UcdFlags                          &flags,
                   std::ostream                            &out)
   {
@@ -3049,7 +3049,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_dx (const std::vector<Patch<dim,spacedim> > &patches,
                  const std::vector<std::string>          &data_names,
-                 const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &,
+                 const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &,
                  const DXFlags                           &flags,
                  std::ostream                            &out)
   {
@@ -3347,7 +3347,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_gnuplot (const std::vector<Patch<dim,spacedim> > &patches,
                       const std::vector<std::string>          &data_names,
-                      const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &,
+                      const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &,
                       const GnuplotFlags                      &/*flags*/,
                       std::ostream                            &out)
   {
@@ -3582,7 +3582,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_povray (const std::vector<Patch<dim,spacedim> > &patches,
                      const std::vector<std::string>          &data_names,
-                     const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &,
+                     const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &,
                      const PovrayFlags                       &flags,
                      std::ostream                            &out)
   {
@@ -3949,7 +3949,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_eps (const std::vector<Patch<dim,spacedim> > &patches,
                   const std::vector<std::string>          &/*data_names*/,
-                  const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &,
+                  const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &,
                   const EpsFlags                          &flags,
                   std::ostream                            &out)
   {
@@ -3961,7 +3961,7 @@ namespace DataOutBase
   template <int spacedim>
   void write_eps (const std::vector<Patch<2,spacedim> > &patches,
                   const std::vector<std::string>          &/*data_names*/,
-                  const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &,
+                  const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &,
                   const EpsFlags                          &flags,
                   std::ostream                            &out)
   {
@@ -4339,7 +4339,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_gmv (const std::vector<Patch<dim,spacedim> > &patches,
                   const std::vector<std::string>          &data_names,
-                  const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &,
+                  const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &,
                   const GmvFlags                          &flags,
                   std::ostream                            &out)
   {
@@ -4494,7 +4494,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_tecplot (const std::vector<Patch<dim,spacedim> > &patches,
                       const std::vector<std::string>          &data_names,
-                      const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &,
+                      const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &,
                       const TecplotFlags                      &flags,
                       std::ostream                            &out)
   {
@@ -4742,7 +4742,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_tecplot_binary (const std::vector<Patch<dim,spacedim> > &patches,
                              const std::vector<std::string>          &data_names,
-                             const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                             const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                              const TecplotFlags                      &flags,
                              std::ostream                            &out)
   {
@@ -5088,7 +5088,7 @@ namespace DataOutBase
   void
   write_vtk (const std::vector<Patch<dim,spacedim> > &patches,
              const std::vector<std::string>          &data_names,
-             const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+             const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
              const VtkFlags                          &flags,
              std::ostream                            &out)
   {
@@ -5260,21 +5260,21 @@ namespace DataOutBase
     std::vector<bool> data_set_written (n_data_sets, false);
     for (unsigned int n_th_vector=0; n_th_vector<vector_data_ranges.size(); ++n_th_vector)
       {
-        AssertThrow (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]) >=
-                     std_cxx1x::get<0>(vector_data_ranges[n_th_vector]),
-                     ExcLowerRange (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]),
-                                    std_cxx1x::get<0>(vector_data_ranges[n_th_vector])));
-        AssertThrow (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]) < n_data_sets,
-                     ExcIndexRange (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]),
+        AssertThrow (std_cxx11::get<1>(vector_data_ranges[n_th_vector]) >=
+                     std_cxx11::get<0>(vector_data_ranges[n_th_vector]),
+                     ExcLowerRange (std_cxx11::get<1>(vector_data_ranges[n_th_vector]),
+                                    std_cxx11::get<0>(vector_data_ranges[n_th_vector])));
+        AssertThrow (std_cxx11::get<1>(vector_data_ranges[n_th_vector]) < n_data_sets,
+                     ExcIndexRange (std_cxx11::get<1>(vector_data_ranges[n_th_vector]),
                                     0, n_data_sets));
-        AssertThrow (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]) + 1
-                     - std_cxx1x::get<0>(vector_data_ranges[n_th_vector]) <= 3,
+        AssertThrow (std_cxx11::get<1>(vector_data_ranges[n_th_vector]) + 1
+                     - std_cxx11::get<0>(vector_data_ranges[n_th_vector]) <= 3,
                      ExcMessage ("Can't declare a vector with more than 3 components "
                                  "in VTK"));
 
         // mark these components as already written:
-        for (unsigned int i=std_cxx1x::get<0>(vector_data_ranges[n_th_vector]);
-             i<=std_cxx1x::get<1>(vector_data_ranges[n_th_vector]);
+        for (unsigned int i=std_cxx11::get<0>(vector_data_ranges[n_th_vector]);
+             i<=std_cxx11::get<1>(vector_data_ranges[n_th_vector]);
              ++i)
           data_set_written[i] = true;
 
@@ -5285,15 +5285,15 @@ namespace DataOutBase
         // name has been specified
         out << "VECTORS ";
 
-        if (std_cxx1x::get<2>(vector_data_ranges[n_th_vector]) != "")
-          out << std_cxx1x::get<2>(vector_data_ranges[n_th_vector]);
+        if (std_cxx11::get<2>(vector_data_ranges[n_th_vector]) != "")
+          out << std_cxx11::get<2>(vector_data_ranges[n_th_vector]);
         else
           {
-            for (unsigned int i=std_cxx1x::get<0>(vector_data_ranges[n_th_vector]);
-                 i<std_cxx1x::get<1>(vector_data_ranges[n_th_vector]);
+            for (unsigned int i=std_cxx11::get<0>(vector_data_ranges[n_th_vector]);
+                 i<std_cxx11::get<1>(vector_data_ranges[n_th_vector]);
                  ++i)
               out << data_names[i] << "__";
-            out << data_names[std_cxx1x::get<1>(vector_data_ranges[n_th_vector])];
+            out << data_names[std_cxx11::get<1>(vector_data_ranges[n_th_vector])];
           }
 
         out << " double"
@@ -5304,20 +5304,20 @@ namespace DataOutBase
         // components
         for (unsigned int n=0; n<n_nodes; ++n)
           {
-            switch (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]) -
-                    std_cxx1x::get<0>(vector_data_ranges[n_th_vector]))
+            switch (std_cxx11::get<1>(vector_data_ranges[n_th_vector]) -
+                    std_cxx11::get<0>(vector_data_ranges[n_th_vector]))
               {
               case 0:
-                out << data_vectors(std_cxx1x::get<0>(vector_data_ranges[n_th_vector]), n) << " 0 0"
+                out << data_vectors(std_cxx11::get<0>(vector_data_ranges[n_th_vector]), n) << " 0 0"
                     << '\n';
                 break;
 
               case 1:
-                out << data_vectors(std_cxx1x::get<0>(vector_data_ranges[n_th_vector]),   n) << ' '<< data_vectors(std_cxx1x::get<0>(vector_data_ranges[n_th_vector])+1, n) << " 0"
+                out << data_vectors(std_cxx11::get<0>(vector_data_ranges[n_th_vector]),   n) << ' '<< data_vectors(std_cxx11::get<0>(vector_data_ranges[n_th_vector])+1, n) << " 0"
                     << '\n';
                 break;
               case 2:
-                out << data_vectors(std_cxx1x::get<0>(vector_data_ranges[n_th_vector]),   n) << ' '<< data_vectors(std_cxx1x::get<0>(vector_data_ranges[n_th_vector])+1, n) << ' '<< data_vectors(std_cxx1x::get<0>(vector_data_ranges[n_th_vector])+2, n)
+                out << data_vectors(std_cxx11::get<0>(vector_data_ranges[n_th_vector]),   n) << ' '<< data_vectors(std_cxx11::get<0>(vector_data_ranges[n_th_vector])+1, n) << ' '<< data_vectors(std_cxx11::get<0>(vector_data_ranges[n_th_vector])+2, n)
                     << '\n';
                 break;
 
@@ -5410,7 +5410,7 @@ namespace DataOutBase
   void
   write_vtu (const std::vector<Patch<dim,spacedim> > &patches,
              const std::vector<std::string>          &data_names,
-             const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+             const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
              const VtkFlags                          &flags,
              std::ostream                            &out)
   {
@@ -5425,7 +5425,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_vtu_main (const std::vector<Patch<dim,spacedim> > &patches,
                        const std::vector<std::string>          &data_names,
-                       const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                       const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                        const VtkFlags                          &flags,
                        std::ostream                            &out)
   {
@@ -5462,8 +5462,8 @@ namespace DataOutBase
           {
             // mark these components as already
             // written:
-            for (unsigned int i=std_cxx1x::get<0>(vector_data_ranges[n_th_vector]);
-                 i<=std_cxx1x::get<1>(vector_data_ranges[n_th_vector]);
+            for (unsigned int i=std_cxx11::get<0>(vector_data_ranges[n_th_vector]);
+                 i<=std_cxx11::get<1>(vector_data_ranges[n_th_vector]);
                  ++i)
               data_set_written[i] = true;
 
@@ -5474,15 +5474,15 @@ namespace DataOutBase
             // name has been specified
             out << "    <DataArray type=\"Float64\" Name=\"";
 
-            if (std_cxx1x::get<2>(vector_data_ranges[n_th_vector]) != "")
-              out << std_cxx1x::get<2>(vector_data_ranges[n_th_vector]);
+            if (std_cxx11::get<2>(vector_data_ranges[n_th_vector]) != "")
+              out << std_cxx11::get<2>(vector_data_ranges[n_th_vector]);
             else
               {
-                for (unsigned int i=std_cxx1x::get<0>(vector_data_ranges[n_th_vector]);
-                     i<std_cxx1x::get<1>(vector_data_ranges[n_th_vector]);
+                for (unsigned int i=std_cxx11::get<0>(vector_data_ranges[n_th_vector]);
+                     i<std_cxx11::get<1>(vector_data_ranges[n_th_vector]);
                      ++i)
                   out << data_names[i] << "__";
-                out << data_names[std_cxx1x::get<1>(vector_data_ranges[n_th_vector])];
+                out << data_names[std_cxx11::get<1>(vector_data_ranges[n_th_vector])];
               }
 
             out << "\" NumberOfComponents=\"3\"></DataArray>\n";
@@ -5680,22 +5680,22 @@ namespace DataOutBase
     std::vector<bool> data_set_written (n_data_sets, false);
     for (unsigned int n_th_vector=0; n_th_vector<vector_data_ranges.size(); ++n_th_vector)
       {
-        AssertThrow (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]) >=
-                     std_cxx1x::get<0>(vector_data_ranges[n_th_vector]),
-                     ExcLowerRange (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]),
-                                    std_cxx1x::get<0>(vector_data_ranges[n_th_vector])));
-        AssertThrow (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]) < n_data_sets,
-                     ExcIndexRange (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]),
+        AssertThrow (std_cxx11::get<1>(vector_data_ranges[n_th_vector]) >=
+                     std_cxx11::get<0>(vector_data_ranges[n_th_vector]),
+                     ExcLowerRange (std_cxx11::get<1>(vector_data_ranges[n_th_vector]),
+                                    std_cxx11::get<0>(vector_data_ranges[n_th_vector])));
+        AssertThrow (std_cxx11::get<1>(vector_data_ranges[n_th_vector]) < n_data_sets,
+                     ExcIndexRange (std_cxx11::get<1>(vector_data_ranges[n_th_vector]),
                                     0, n_data_sets));
-        AssertThrow (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]) + 1
-                     - std_cxx1x::get<0>(vector_data_ranges[n_th_vector]) <= 3,
+        AssertThrow (std_cxx11::get<1>(vector_data_ranges[n_th_vector]) + 1
+                     - std_cxx11::get<0>(vector_data_ranges[n_th_vector]) <= 3,
                      ExcMessage ("Can't declare a vector with more than 3 components "
                                  "in VTK"));
 
         // mark these components as already
         // written:
-        for (unsigned int i=std_cxx1x::get<0>(vector_data_ranges[n_th_vector]);
-             i<=std_cxx1x::get<1>(vector_data_ranges[n_th_vector]);
+        for (unsigned int i=std_cxx11::get<0>(vector_data_ranges[n_th_vector]);
+             i<=std_cxx11::get<1>(vector_data_ranges[n_th_vector]);
              ++i)
           data_set_written[i] = true;
 
@@ -5706,15 +5706,15 @@ namespace DataOutBase
         // name has been specified
         out << "    <DataArray type=\"Float64\" Name=\"";
 
-        if (std_cxx1x::get<2>(vector_data_ranges[n_th_vector]) != "")
-          out << std_cxx1x::get<2>(vector_data_ranges[n_th_vector]);
+        if (std_cxx11::get<2>(vector_data_ranges[n_th_vector]) != "")
+          out << std_cxx11::get<2>(vector_data_ranges[n_th_vector]);
         else
           {
-            for (unsigned int i=std_cxx1x::get<0>(vector_data_ranges[n_th_vector]);
-                 i<std_cxx1x::get<1>(vector_data_ranges[n_th_vector]);
+            for (unsigned int i=std_cxx11::get<0>(vector_data_ranges[n_th_vector]);
+                 i<std_cxx11::get<1>(vector_data_ranges[n_th_vector]);
                  ++i)
               out << data_names[i] << "__";
-            out << data_names[std_cxx1x::get<1>(vector_data_ranges[n_th_vector])];
+            out << data_names[std_cxx11::get<1>(vector_data_ranges[n_th_vector])];
           }
 
         out << "\" NumberOfComponents=\"3\" format=\""
@@ -5728,24 +5728,24 @@ namespace DataOutBase
 
         for (unsigned int n=0; n<n_nodes; ++n)
           {
-            switch (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]) -
-                    std_cxx1x::get<0>(vector_data_ranges[n_th_vector]))
+            switch (std_cxx11::get<1>(vector_data_ranges[n_th_vector]) -
+                    std_cxx11::get<0>(vector_data_ranges[n_th_vector]))
               {
               case 0:
-                data.push_back (data_vectors(std_cxx1x::get<0>(vector_data_ranges[n_th_vector]), n));
+                data.push_back (data_vectors(std_cxx11::get<0>(vector_data_ranges[n_th_vector]), n));
                 data.push_back (0);
                 data.push_back (0);
                 break;
 
               case 1:
-                data.push_back (data_vectors(std_cxx1x::get<0>(vector_data_ranges[n_th_vector]),   n));
-                data.push_back (data_vectors(std_cxx1x::get<0>(vector_data_ranges[n_th_vector])+1, n));
+                data.push_back (data_vectors(std_cxx11::get<0>(vector_data_ranges[n_th_vector]),   n));
+                data.push_back (data_vectors(std_cxx11::get<0>(vector_data_ranges[n_th_vector])+1, n));
                 data.push_back (0);
                 break;
               case 2:
-                data.push_back (data_vectors(std_cxx1x::get<0>(vector_data_ranges[n_th_vector]),   n));
-                data.push_back (data_vectors(std_cxx1x::get<0>(vector_data_ranges[n_th_vector])+1, n));
-                data.push_back (data_vectors(std_cxx1x::get<0>(vector_data_ranges[n_th_vector])+2, n));
+                data.push_back (data_vectors(std_cxx11::get<0>(vector_data_ranges[n_th_vector]),   n));
+                data.push_back (data_vectors(std_cxx11::get<0>(vector_data_ranges[n_th_vector])+1, n));
+                data.push_back (data_vectors(std_cxx11::get<0>(vector_data_ranges[n_th_vector])+2, n));
                 break;
 
               default:
@@ -5794,7 +5794,7 @@ namespace DataOutBase
   template <int dim, int spacedim>
   void write_svg (const std::vector<Patch<dim,spacedim> > &,
                   const std::vector<std::string> &,
-                  const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &,
+                  const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &,
                   const SvgFlags &,
                   std::ostream &)
   {
@@ -5804,7 +5804,7 @@ namespace DataOutBase
   template <int spacedim>
   void write_svg (const std::vector<Patch<2,spacedim> > &patches,
                   const std::vector<std::string> &data_names,
-                  const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                  const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                   const SvgFlags &flags,
                   std::ostream &out)
   {
@@ -6446,7 +6446,7 @@ namespace DataOutBase
   void
   write_deal_II_intermediate (const std::vector<Patch<dim,spacedim> > &patches,
                               const std::vector<std::string>          &data_names,
-                              const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                              const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                               const Deal_II_IntermediateFlags         &/*flags*/,
                               std::ostream                            &out)
   {
@@ -6474,9 +6474,9 @@ namespace DataOutBase
 
     out << vector_data_ranges.size() << '\n';
     for (unsigned int i=0; i<vector_data_ranges.size(); ++i)
-      out << std_cxx1x::get<0>(vector_data_ranges[i]) << ' '
-          << std_cxx1x::get<1>(vector_data_ranges[i]) << '\n'
-          << std_cxx1x::get<2>(vector_data_ranges[i]) << '\n';
+      out << std_cxx11::get<0>(vector_data_ranges[i]) << ' '
+          << std_cxx11::get<1>(vector_data_ranges[i]) << '\n'
+          << std_cxx11::get<2>(vector_data_ranges[i]) << '\n';
 
     out << '\n';
     // make sure everything now gets to
@@ -6732,7 +6732,7 @@ DataOutInterface<dim,spacedim>::write_pvtu_record (std::ostream &out,
   AssertThrow (out, ExcIO());
 
   const std::vector<std::string> data_names = get_dataset_names();
-  const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > vector_data_ranges
+  const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > vector_data_ranges
     = get_vector_data_ranges();
 
   const unsigned int n_data_sets = data_names.size();
@@ -6760,22 +6760,22 @@ DataOutInterface<dim,spacedim>::write_pvtu_record (std::ostream &out,
   std::vector<bool> data_set_written (n_data_sets, false);
   for (unsigned int n_th_vector=0; n_th_vector<vector_data_ranges.size(); ++n_th_vector)
     {
-      AssertThrow (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]) >=
-                   std_cxx1x::get<0>(vector_data_ranges[n_th_vector]),
-                   ExcLowerRange (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]),
-                                  std_cxx1x::get<0>(vector_data_ranges[n_th_vector])));
-      AssertThrow (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]) < n_data_sets,
-                   ExcIndexRange (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]),
+      AssertThrow (std_cxx11::get<1>(vector_data_ranges[n_th_vector]) >=
+                   std_cxx11::get<0>(vector_data_ranges[n_th_vector]),
+                   ExcLowerRange (std_cxx11::get<1>(vector_data_ranges[n_th_vector]),
+                                  std_cxx11::get<0>(vector_data_ranges[n_th_vector])));
+      AssertThrow (std_cxx11::get<1>(vector_data_ranges[n_th_vector]) < n_data_sets,
+                   ExcIndexRange (std_cxx11::get<1>(vector_data_ranges[n_th_vector]),
                                   0, n_data_sets));
-      AssertThrow (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]) + 1
-                   - std_cxx1x::get<0>(vector_data_ranges[n_th_vector]) <= 3,
+      AssertThrow (std_cxx11::get<1>(vector_data_ranges[n_th_vector]) + 1
+                   - std_cxx11::get<0>(vector_data_ranges[n_th_vector]) <= 3,
                    ExcMessage ("Can't declare a vector with more than 3 components "
                                "in VTK"));
 
       // mark these components as already
       // written:
-      for (unsigned int i=std_cxx1x::get<0>(vector_data_ranges[n_th_vector]);
-           i<=std_cxx1x::get<1>(vector_data_ranges[n_th_vector]);
+      for (unsigned int i=std_cxx11::get<0>(vector_data_ranges[n_th_vector]);
+           i<=std_cxx11::get<1>(vector_data_ranges[n_th_vector]);
            ++i)
         data_set_written[i] = true;
 
@@ -6786,15 +6786,15 @@ DataOutInterface<dim,spacedim>::write_pvtu_record (std::ostream &out,
       // name has been specified
       out << "    <PDataArray type=\"Float64\" Name=\"";
 
-      if (std_cxx1x::get<2>(vector_data_ranges[n_th_vector]) != "")
-        out << std_cxx1x::get<2>(vector_data_ranges[n_th_vector]);
+      if (std_cxx11::get<2>(vector_data_ranges[n_th_vector]) != "")
+        out << std_cxx11::get<2>(vector_data_ranges[n_th_vector]);
       else
         {
-          for (unsigned int i=std_cxx1x::get<0>(vector_data_ranges[n_th_vector]);
-               i<std_cxx1x::get<1>(vector_data_ranges[n_th_vector]);
+          for (unsigned int i=std_cxx11::get<0>(vector_data_ranges[n_th_vector]);
+               i<std_cxx11::get<1>(vector_data_ranges[n_th_vector]);
                ++i)
             out << data_names[i] << "__";
-          out << data_names[std_cxx1x::get<1>(vector_data_ranges[n_th_vector])];
+          out << data_names[std_cxx11::get<1>(vector_data_ranges[n_th_vector])];
         }
 
       out << "\" NumberOfComponents=\"3\" format=\"ascii\"/>\n";
@@ -7062,7 +7062,7 @@ write_filtered_data (DataOutBase::DataOutFilter &filtered_data) const
 template <int dim, int spacedim>
 void DataOutBase::write_filtered_data (const std::vector<Patch<dim,spacedim> > &patches,
                                        const std::vector<std::string>          &data_names,
-                                       const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                                       const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                                        DataOutBase::DataOutFilter &filtered_data)
 {
   const unsigned int n_data_sets = data_names.size();
@@ -7109,35 +7109,35 @@ void DataOutBase::write_filtered_data (const std::vector<Patch<dim,spacedim> > &
   for (n_th_vector=0,data_set=0; data_set<n_data_sets;)
     {
       // Advance n_th_vector to at least the current data set we are on
-      while (n_th_vector < vector_data_ranges.size() && std_cxx1x::get<0>(vector_data_ranges[n_th_vector]) < data_set) n_th_vector++;
+      while (n_th_vector < vector_data_ranges.size() && std_cxx11::get<0>(vector_data_ranges[n_th_vector]) < data_set) n_th_vector++;
 
       // Determine the dimension of this data
-      if (n_th_vector < vector_data_ranges.size() && std_cxx1x::get<0>(vector_data_ranges[n_th_vector]) == data_set)
+      if (n_th_vector < vector_data_ranges.size() && std_cxx11::get<0>(vector_data_ranges[n_th_vector]) == data_set)
         {
           // Multiple dimensions
-          pt_data_vector_dim = std_cxx1x::get<1>(vector_data_ranges[n_th_vector]) - std_cxx1x::get<0>(vector_data_ranges[n_th_vector])+1;
+          pt_data_vector_dim = std_cxx11::get<1>(vector_data_ranges[n_th_vector]) - std_cxx11::get<0>(vector_data_ranges[n_th_vector])+1;
 
           // Ensure the dimensionality of the data is correct
-          AssertThrow (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]) >= std_cxx1x::get<0>(vector_data_ranges[n_th_vector]),
-                       ExcLowerRange (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]), std_cxx1x::get<0>(vector_data_ranges[n_th_vector])));
-          AssertThrow (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]) < n_data_sets,
-                       ExcIndexRange (std_cxx1x::get<1>(vector_data_ranges[n_th_vector]), 0, n_data_sets));
+          AssertThrow (std_cxx11::get<1>(vector_data_ranges[n_th_vector]) >= std_cxx11::get<0>(vector_data_ranges[n_th_vector]),
+                       ExcLowerRange (std_cxx11::get<1>(vector_data_ranges[n_th_vector]), std_cxx11::get<0>(vector_data_ranges[n_th_vector])));
+          AssertThrow (std_cxx11::get<1>(vector_data_ranges[n_th_vector]) < n_data_sets,
+                       ExcIndexRange (std_cxx11::get<1>(vector_data_ranges[n_th_vector]), 0, n_data_sets));
 
           // Determine the vector name
           // Concatenate all the
           // component names with double
           // underscores unless a vector
           // name has been specified
-          if (std_cxx1x::get<2>(vector_data_ranges[n_th_vector]) != "")
+          if (std_cxx11::get<2>(vector_data_ranges[n_th_vector]) != "")
             {
-              vector_name = std_cxx1x::get<2>(vector_data_ranges[n_th_vector]);
+              vector_name = std_cxx11::get<2>(vector_data_ranges[n_th_vector]);
             }
           else
             {
               vector_name = "";
-              for (i=std_cxx1x::get<0>(vector_data_ranges[n_th_vector]); i<std_cxx1x::get<1>(vector_data_ranges[n_th_vector]); ++i)
+              for (i=std_cxx11::get<0>(vector_data_ranges[n_th_vector]); i<std_cxx11::get<1>(vector_data_ranges[n_th_vector]); ++i)
                 vector_name += data_names[i] + "__";
-              vector_name += data_names[std_cxx1x::get<1>(vector_data_ranges[n_th_vector])];
+              vector_name += data_names[std_cxx11::get<1>(vector_data_ranges[n_th_vector])];
             }
         }
       else
@@ -7767,10 +7767,10 @@ DataOutInterface<dim,spacedim>::memory_consumption () const
 
 
 template <int dim, int spacedim>
-std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> >
+std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> >
 DataOutInterface<dim,spacedim>::get_vector_data_ranges () const
 {
-  return std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> >();
+  return std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> >();
 }
 
 
@@ -7795,7 +7795,7 @@ DataOutReader<dim,spacedim>::read (std::istream &in)
     tmp.swap (dataset_names);
   }
   {
-    std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > tmp;
+    std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > tmp;
     tmp.swap (vector_data_ranges);
   }
 
@@ -7870,8 +7870,8 @@ DataOutReader<dim,spacedim>::read (std::istream &in)
   vector_data_ranges.resize (n_vector_data_ranges);
   for (unsigned int i=0; i<n_vector_data_ranges; ++i)
     {
-      in >> std_cxx1x::get<0>(vector_data_ranges[i])
-         >> std_cxx1x::get<1>(vector_data_ranges[i]);
+      in >> std_cxx11::get<0>(vector_data_ranges[i])
+         >> std_cxx11::get<1>(vector_data_ranges[i]);
 
       // read in the name of that vector
       // range. because it is on a separate
@@ -7884,7 +7884,7 @@ DataOutReader<dim,spacedim>::read (std::istream &in)
       std::string name;
       getline(in, name);
       getline(in, name);
-      std_cxx1x::get<2>(vector_data_ranges[i]) = name;
+      std_cxx11::get<2>(vector_data_ranges[i]) = name;
     }
 
   Assert (in, ExcIO());
@@ -7916,16 +7916,16 @@ merge (const DataOutReader<dim,spacedim> &source)
                       "as vectors."));
   for (unsigned int i=0; i<get_vector_data_ranges().size(); ++i)
     {
-      Assert (std_cxx1x::get<0>(get_vector_data_ranges()[i]) ==
-              std_cxx1x::get<0>(source.get_vector_data_ranges()[i]),
+      Assert (std_cxx11::get<0>(get_vector_data_ranges()[i]) ==
+              std_cxx11::get<0>(source.get_vector_data_ranges()[i]),
               ExcMessage ("Both sources need to declare the same components "
                           "as vectors."));
-      Assert (std_cxx1x::get<1>(get_vector_data_ranges()[i]) ==
-              std_cxx1x::get<1>(source.get_vector_data_ranges()[i]),
+      Assert (std_cxx11::get<1>(get_vector_data_ranges()[i]) ==
+              std_cxx11::get<1>(source.get_vector_data_ranges()[i]),
               ExcMessage ("Both sources need to declare the same components "
                           "as vectors."));
-      Assert (std_cxx1x::get<2>(get_vector_data_ranges()[i]) ==
-              std_cxx1x::get<2>(source.get_vector_data_ranges()[i]),
+      Assert (std_cxx11::get<2>(get_vector_data_ranges()[i]) ==
+              std_cxx11::get<2>(source.get_vector_data_ranges()[i]),
               ExcMessage ("Both sources need to declare the same components "
                           "as vectors."));
     }
@@ -7979,7 +7979,7 @@ DataOutReader<dim,spacedim>::get_dataset_names () const
 
 
 template <int dim, int spacedim>
-std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> >
+std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> >
 DataOutReader<dim,spacedim>::get_vector_data_ranges () const
 {
   return vector_data_ranges;
index dc4ea5982367ae6987d62f6d2c7aa9094e09af01..b1f0567c6beac95535ff3f7a33c9dd40e9b347b5 100644 (file)
@@ -39,7 +39,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
   void
   write_vtk (const std::vector<Patch<deal_II_dimension,deal_II_space_dimension> > &patches,
                         const std::vector<std::string>          &data_names,
-                        const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                        const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                         const VtkFlags                          &flags,
                         std::ostream                            &out);
 
@@ -47,7 +47,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
   void
   write_vtu (const std::vector<Patch<deal_II_dimension,deal_II_space_dimension> > &patches,
                         const std::vector<std::string>          &data_names,
-                        const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                        const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                         const VtkFlags                          &flags,
                         std::ostream                            &out);
 
@@ -55,7 +55,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
   void
   write_ucd (const std::vector<Patch<deal_II_dimension,deal_II_space_dimension> > &patches,
                         const std::vector<std::string>          &data_names,
-                        const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                        const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                         const UcdFlags                          &flags,
                         std::ostream                            &out);
 
@@ -63,7 +63,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
   void
   write_dx (const std::vector<Patch<deal_II_dimension,deal_II_space_dimension> > &patches,
                         const std::vector<std::string>          &data_names,
-                        const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                        const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                         const DXFlags                          &flags,
                         std::ostream                            &out);
 
@@ -71,7 +71,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
   void
   write_gnuplot (const std::vector<Patch<deal_II_dimension,deal_II_space_dimension> > &patches,
                         const std::vector<std::string>          &data_names,
-                        const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                        const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                         const GnuplotFlags                          &flags,
                         std::ostream                            &out);
 
@@ -79,7 +79,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
   void
   write_povray (const std::vector<Patch<deal_II_dimension,deal_II_space_dimension> > &patches,
                         const std::vector<std::string>          &data_names,
-                        const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                        const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                         const PovrayFlags                          &flags,
                         std::ostream                            &out);
 
@@ -87,7 +87,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
   void
   write_eps (const std::vector<Patch<deal_II_dimension,deal_II_space_dimension> > &patches,
                         const std::vector<std::string>          &data_names,
-                        const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                        const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                         const EpsFlags                          &flags,
                         std::ostream                            &out);
 
@@ -95,7 +95,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
   void
   write_gmv (const std::vector<Patch<deal_II_dimension,deal_II_space_dimension> > &patches,
                         const std::vector<std::string>          &data_names,
-                        const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                        const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                         const GmvFlags                          &flags,
                         std::ostream                            &out);
 
@@ -103,7 +103,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
   void
   write_tecplot (const std::vector<Patch<deal_II_dimension,deal_II_space_dimension> > &patches,
                         const std::vector<std::string>          &data_names,
-                        const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                        const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                         const TecplotFlags                          &flags,
                         std::ostream                            &out);
 
@@ -111,7 +111,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
   void
   write_tecplot_binary (const std::vector<Patch<deal_II_dimension,deal_II_space_dimension> > &patches,
                         const std::vector<std::string>          &data_names,
-                        const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                        const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                         const TecplotFlags                          &flags,
                         std::ostream                            &out);
 
@@ -120,7 +120,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
   void
   write_svg (const std::vector<Patch<deal_II_dimension,deal_II_space_dimension> > &patches,
                         const std::vector<std::string>          &data_names,
-                        const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                        const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                         const SvgFlags                          &flags,
                         std::ostream                            &out);
 #endif
@@ -128,7 +128,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
   void
   write_deal_II_intermediate (const std::vector<Patch<deal_II_dimension,deal_II_space_dimension> > &patches,
                         const std::vector<std::string>          &data_names,
-                        const std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                        const std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                         const Deal_II_IntermediateFlags                          &flags,
                         std::ostream                            &out);
   \}
index 7850cc6eb7b22a257424baa47f3257b95d824425..7e3e33cecff781bb7966656583b55e4829b2ce4e 100644 (file)
@@ -521,7 +521,7 @@ ComponentSelectFunction<dim, Number>::memory_consumption () const
 
 template <int dim, typename Number>
 ScalarFunctionFromFunctionObject<dim, Number>::
-ScalarFunctionFromFunctionObject (const std_cxx1x::function<Number (const Point<dim, Number> &)> &function_object)
+ScalarFunctionFromFunctionObject (const std_cxx11::function<Number (const Point<dim, Number> &)> &function_object)
   :
   Function<dim, Number>(1),
   function_object (function_object)
@@ -543,7 +543,7 @@ ScalarFunctionFromFunctionObject<dim, Number>::value (const Point<dim, Number> &
 
 template <int dim, typename Number>
 VectorFunctionFromScalarFunctionObject<dim, Number>::
-VectorFunctionFromScalarFunctionObject (const std_cxx1x::function<Number (const Point<dim, Number> &)> &function_object,
+VectorFunctionFromScalarFunctionObject (const std_cxx11::function<Number (const Point<dim, Number> &)> &function_object,
                                         const unsigned int selected_component,
                                         const unsigned int n_components)
   :
index 46c1c5d95ad6132b556be716c59c25c2c3ad2694..c4d9c119e1c6f14d67733ff1d1e70fb0f9a20f3d 100644 (file)
@@ -2318,7 +2318,7 @@ namespace Functions
 
   template <int dim>
   InterpolatedTensorProductGridData<dim>::
-  InterpolatedTensorProductGridData(const std_cxx1x::array<std::vector<double>,dim> &coordinate_values,
+  InterpolatedTensorProductGridData(const std_cxx11::array<std::vector<double>,dim> &coordinate_values,
                                     const Table<dim,double>                         &data_values)
     :
     coordinate_values (coordinate_values),
@@ -2389,8 +2389,8 @@ namespace Functions
 
   template <int dim>
   InterpolatedUniformGridData<dim>::
-  InterpolatedUniformGridData(const std_cxx1x::array<std::pair<double,double>,dim> &interval_endpoints,
-                              const std_cxx1x::array<unsigned int,dim>             &n_subintervals,
+  InterpolatedUniformGridData(const std_cxx11::array<std::pair<double,double>,dim> &interval_endpoints,
+                              const std_cxx11::array<unsigned int,dim>             &n_subintervals,
                               const Table<dim,double>                              &data_values)
     :
     interval_endpoints (interval_endpoints),
index f8e14067a142df11afbd211369fc2019faa35add..7c2e5b2c6f00111bb8b3320b34e280226a4a50c2 100644 (file)
@@ -548,7 +548,7 @@ namespace Patterns
         std::string str;
         std::getline(is, str, '>');
 
-        std_cxx1x::shared_ptr<PatternBase> base_pattern (pattern_factory(str));
+        std_cxx11::shared_ptr<PatternBase> base_pattern (pattern_factory(str));
 
         is.ignore(strlen(" of length "));
         if (!(is >> min_elements))
@@ -737,8 +737,8 @@ namespace Patterns
         std::string value = str;
         value.erase (0, value.find(":")+1);
 
-        std_cxx1x::shared_ptr<PatternBase> key_pattern (pattern_factory(key));
-        std_cxx1x::shared_ptr<PatternBase> value_pattern (pattern_factory(value));
+        std_cxx11::shared_ptr<PatternBase> key_pattern (pattern_factory(key));
+        std_cxx11::shared_ptr<PatternBase> value_pattern (pattern_factory(value));
 
         is.ignore(strlen(" of length "));
         if (!(is >> min_elements))
@@ -1389,7 +1389,7 @@ namespace
   read_xml_recursively (const boost::property_tree::ptree &source,
                         const std::string                 &current_path,
                         const char                         path_separator,
-                        const std::vector<std_cxx1x::shared_ptr<const Patterns::PatternBase> > &
+                        const std::vector<std_cxx11::shared_ptr<const Patterns::PatternBase> > &
                         patterns,
                         boost::property_tree::ptree       &destination)
   {
@@ -1563,7 +1563,7 @@ ParameterHandler::declare_entry (const std::string           &entry,
 
   // clone the pattern and store its
   // index in the node
-  patterns.push_back (std_cxx1x::shared_ptr<const Patterns::PatternBase>
+  patterns.push_back (std_cxx11::shared_ptr<const Patterns::PatternBase>
                       (pattern.clone()));
   entries->put (get_current_full_path(entry) + path_separator + "pattern",
                 static_cast<unsigned int>(patterns.size()-1));
index f6fa8b2f3c16d7b6a0c852fdbbbb16f80669e2d7..4f459c7580e8b2094bc47f3077634f5f6e6d1fd5 100644 (file)
@@ -360,7 +360,7 @@ namespace Polynomials
     // need to transform p into standard form as
     // well if necessary. copy the polynomial to
     // do this
-    std_cxx1x::shared_ptr<Polynomial<number> > q_data;
+    std_cxx11::shared_ptr<Polynomial<number> > q_data;
     const Polynomial<number> *q = 0;
     if (p.in_lagrange_product_form == true)
       {
@@ -404,7 +404,7 @@ namespace Polynomials
     // need to transform p into standard form as
     // well if necessary. copy the polynomial to
     // do this
-    std_cxx1x::shared_ptr<Polynomial<number> > q_data;
+    std_cxx11::shared_ptr<Polynomial<number> > q_data;
     const Polynomial<number> *q = 0;
     if (p.in_lagrange_product_form == true)
       {
@@ -440,7 +440,7 @@ namespace Polynomials
     // need to transform p into standard form as
     // well if necessary. copy the polynomial to
     // do this
-    std_cxx1x::shared_ptr<Polynomial<number> > q_data;
+    std_cxx11::shared_ptr<Polynomial<number> > q_data;
     const Polynomial<number> *q = 0;
     if (p.in_lagrange_product_form == true)
       {
@@ -587,7 +587,7 @@ namespace Polynomials
     if (degree() == 0)
       return Monomial<number>(0, 0.);
 
-    std_cxx1x::shared_ptr<Polynomial<number> > q_data;
+    std_cxx11::shared_ptr<Polynomial<number> > q_data;
     const Polynomial<number> *q = 0;
     if (in_lagrange_product_form == true)
       {
@@ -613,7 +613,7 @@ namespace Polynomials
   {
     // no simple form possible for Lagrange
     // polynomial on product form
-    std_cxx1x::shared_ptr<Polynomial<number> > q_data;
+    std_cxx11::shared_ptr<Polynomial<number> > q_data;
     const Polynomial<number> *q = 0;
     if (in_lagrange_product_form == true)
       {
@@ -833,9 +833,9 @@ namespace Polynomials
 
 // Reserve space for polynomials up to degree 19. Should be sufficient
 // for the start.
-  std::vector<std_cxx1x::shared_ptr<const std::vector<double> > >
+  std::vector<std_cxx11::shared_ptr<const std::vector<double> > >
   Legendre::recursive_coefficients(20);
-  std::vector<std_cxx1x::shared_ptr<const std::vector<double> > >
+  std::vector<std_cxx11::shared_ptr<const std::vector<double> > >
   Legendre::shifted_coefficients(20);
 
 
@@ -877,7 +877,7 @@ namespace Polynomials
     if ((recursive_coefficients.size() < k+1) ||
         ((recursive_coefficients.size() >= k+1) &&
          (recursive_coefficients[k] ==
-          std_cxx1x::shared_ptr<const std::vector<double> >())))
+          std_cxx11::shared_ptr<const std::vector<double> >())))
       // no, then generate the
       // respective coefficients
       {
@@ -925,9 +925,9 @@ namespace Polynomials
             // would appear if we used plain
             // pointers.
             recursive_coefficients[0] =
-              std_cxx1x::shared_ptr<const std::vector<double> >(c0);
+              std_cxx11::shared_ptr<const std::vector<double> >(c0);
             recursive_coefficients[1] =
-              std_cxx1x::shared_ptr<const std::vector<double> >(c1);
+              std_cxx11::shared_ptr<const std::vector<double> >(c1);
 
             // Compute polynomials
             // orthogonal on [0,1]
@@ -939,8 +939,8 @@ namespace Polynomials
             Polynomial<double>::shift<SHIFT_TYPE> (*c1, -1.);
             Polynomial<double>::scale(*c1, 2.);
             Polynomial<double>::multiply(*c1, std::sqrt(3.));
-            shifted_coefficients[0]=std_cxx1x::shared_ptr<const std::vector<double> >(c0);
-            shifted_coefficients[1]=std_cxx1x::shared_ptr<const std::vector<double> >(c1);
+            shifted_coefficients[0]=std_cxx11::shared_ptr<const std::vector<double> >(c0);
+            shifted_coefficients[1]=std_cxx11::shared_ptr<const std::vector<double> >(c1);
           }
         else
           {
@@ -975,7 +975,7 @@ namespace Polynomials
             // const pointer in the
             // coefficients array
             recursive_coefficients[k] =
-              std_cxx1x::shared_ptr<const std::vector<double> >(ck);
+              std_cxx11::shared_ptr<const std::vector<double> >(ck);
             // and compute the
             // coefficients for [0,1]
             ck = new std::vector<double>(*ck);
@@ -983,7 +983,7 @@ namespace Polynomials
             Polynomial<double>::scale(*ck, 2.);
             Polynomial<double>::multiply(*ck, std::sqrt(2.*k+1.));
             shifted_coefficients[k] =
-              std_cxx1x::shared_ptr<const std::vector<double> >(ck);
+              std_cxx11::shared_ptr<const std::vector<double> >(ck);
           };
       };
   }
@@ -1110,7 +1110,7 @@ namespace Polynomials
 
 // Reserve space for polynomials up to degree 19. Should be sufficient
 // for the start.
-  std::vector<std_cxx1x::shared_ptr<const std::vector<double> > >
+  std::vector<std_cxx11::shared_ptr<const std::vector<double> > >
   Hierarchical::recursive_coefficients(20);
 
 
@@ -1187,9 +1187,9 @@ namespace Polynomials
             // now make these arrays
             // const
             recursive_coefficients[0] =
-              std_cxx1x::shared_ptr<const std::vector<double> >(c0);
+              std_cxx11::shared_ptr<const std::vector<double> >(c0);
             recursive_coefficients[1] =
-              std_cxx1x::shared_ptr<const std::vector<double> >(c1);
+              std_cxx11::shared_ptr<const std::vector<double> >(c1);
           }
         else if (k==2)
           {
@@ -1206,7 +1206,7 @@ namespace Polynomials
             (*c2)[2] =   4.*a;
 
             recursive_coefficients[2] =
-              std_cxx1x::shared_ptr<const std::vector<double> >(c2);
+              std_cxx11::shared_ptr<const std::vector<double> >(c2);
           }
         else
           {
@@ -1250,7 +1250,7 @@ namespace Polynomials
             // const pointer in the
             // coefficients array
             recursive_coefficients[k] =
-              std_cxx1x::shared_ptr<const std::vector<double> >(ck);
+              std_cxx11::shared_ptr<const std::vector<double> >(ck);
           };
       };
   }
index f5aced6a3e968c8a8598bbcd749eec47092ab551..a979e37b20cc8b1092c45b2574540151c8b82551 100644 (file)
@@ -35,7 +35,7 @@
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
 
-#include <deal.II/base/std_cxx1x/bind.h>
+#include <deal.II/base/std_cxx11/bind.h>
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -85,11 +85,11 @@ namespace parallel
 
       offset
         = tria->register_data_attach(size,
-                                     std_cxx1x::bind(&SolutionTransfer<dim, VECTOR, DH>::pack_callback,
+                                     std_cxx11::bind(&SolutionTransfer<dim, VECTOR, DH>::pack_callback,
                                                      this,
-                                                     std_cxx1x::_1,
-                                                     std_cxx1x::_2,
-                                                     std_cxx1x::_3));
+                                                     std_cxx11::_1,
+                                                     std_cxx11::_2,
+                                                     std_cxx11::_3));
 
     }
 
@@ -168,12 +168,12 @@ namespace parallel
       Assert (tria != 0, ExcInternalError());
 
       tria->notify_ready_to_unpack(offset,
-                                   std_cxx1x::bind(&SolutionTransfer<dim, VECTOR, DH>::unpack_callback,
+                                   std_cxx11::bind(&SolutionTransfer<dim, VECTOR, DH>::unpack_callback,
                                                    this,
-                                                   std_cxx1x::_1,
-                                                   std_cxx1x::_2,
-                                                   std_cxx1x::_3,
-                                                   std_cxx1x::ref(all_out)));
+                                                   std_cxx11::_1,
+                                                   std_cxx11::_2,
+                                                   std_cxx11::_3,
+                                                   std_cxx11::ref(all_out)));
 
 
       for (typename std::vector<VECTOR *>::iterator it=all_out.begin();
index e25b5a8a93fee53fecb55444ca3fdd469528ab25..fe4cd363f99da202bae21f23d2b8044832fd08e9 100644 (file)
@@ -1369,13 +1369,13 @@ namespace
   attach_mesh_data_recursively (const typename internal::p4est::types<dim>::tree &tree,
                                 const typename Triangulation<dim,spacedim>::cell_iterator &dealii_cell,
                                 const typename internal::p4est::types<dim>::quadrant &p4est_cell,
-                                const typename std::list<std::pair<unsigned int, typename std_cxx1x::function<
+                                const typename std::list<std::pair<unsigned int, typename std_cxx11::function<
                                 void(typename parallel::distributed::Triangulation<dim,spacedim>::cell_iterator,
                                      typename parallel::distributed::Triangulation<dim,spacedim>::CellStatus,
                                      void *)
                                 > > > &attached_data_pack_callbacks)
   {
-    typedef std::list<std::pair<unsigned int, typename std_cxx1x::function<
+    typedef std::list<std::pair<unsigned int, typename std_cxx11::function<
     void(typename parallel::distributed::Triangulation<dim,spacedim>::cell_iterator,
          typename parallel::distributed::Triangulation<dim,spacedim>::CellStatus,
          void *)
@@ -1530,7 +1530,7 @@ namespace
                               const typename Triangulation<dim,spacedim>::cell_iterator &parent_cell,
                               const typename internal::p4est::types<dim>::quadrant &p4est_cell,
                               const unsigned int offset,
-                              const typename std_cxx1x::function<
+                              const typename std_cxx11::function<
                               void(typename parallel::distributed::Triangulation<dim,spacedim>::cell_iterator, typename parallel::distributed::Triangulation<dim,spacedim>::CellStatus, void *)
                               > &unpack_callback)
   {
@@ -3233,7 +3233,7 @@ namespace parallel
     unsigned int
     Triangulation<dim,spacedim>::
     register_data_attach (const std::size_t size,
-                          const std_cxx1x::function<void(const cell_iterator &,
+                          const std_cxx11::function<void(const cell_iterator &,
                                                          const CellStatus,
                                                          void *)> &pack_callback)
     {
@@ -3256,7 +3256,7 @@ namespace parallel
     void
     Triangulation<dim,spacedim>::
     notify_ready_to_unpack (const unsigned int offset,
-                            const std_cxx1x::function<void (const cell_iterator &,
+                            const std_cxx11::function<void (const cell_iterator &,
                                                             const CellStatus,
                                                             const void *)> &unpack_callback)
     {
index 78574d8848fa7e0e275d4371c4d624715e532697..21f2c9723a40d32c8903245160ae8150cb8ea7e8 100644 (file)
@@ -306,11 +306,11 @@ namespace DoFTools
       ensure_existence_of_master_dof_mask (const FiniteElement<dim,spacedim> &fe1,
                                            const FiniteElement<dim,spacedim> &fe2,
                                            const FullMatrix<double> &face_interpolation_matrix,
-                                           std_cxx1x::shared_ptr<std::vector<bool> > &master_dof_mask)
+                                           std_cxx11::shared_ptr<std::vector<bool> > &master_dof_mask)
       {
-        if (master_dof_mask == std_cxx1x::shared_ptr<std::vector<bool> >())
+        if (master_dof_mask == std_cxx11::shared_ptr<std::vector<bool> >())
           {
-            master_dof_mask = std_cxx1x::shared_ptr<std::vector<bool> >
+            master_dof_mask = std_cxx11::shared_ptr<std::vector<bool> >
                               (new std::vector<bool> (fe1.dofs_per_face));
             select_master_dofs_for_face_restriction (fe1,
                                                      fe2,
@@ -331,11 +331,11 @@ namespace DoFTools
       void
       ensure_existence_of_face_matrix (const FiniteElement<dim,spacedim> &fe1,
                                        const FiniteElement<dim,spacedim> &fe2,
-                                       std_cxx1x::shared_ptr<FullMatrix<double> > &matrix)
+                                       std_cxx11::shared_ptr<FullMatrix<double> > &matrix)
       {
-        if (matrix == std_cxx1x::shared_ptr<FullMatrix<double> >())
+        if (matrix == std_cxx11::shared_ptr<FullMatrix<double> >())
           {
-            matrix = std_cxx1x::shared_ptr<FullMatrix<double> >
+            matrix = std_cxx11::shared_ptr<FullMatrix<double> >
                      (new FullMatrix<double> (fe2.dofs_per_face,
                                               fe1.dofs_per_face));
             fe1.get_face_interpolation_matrix (fe2,
@@ -353,11 +353,11 @@ namespace DoFTools
       ensure_existence_of_subface_matrix (const FiniteElement<dim,spacedim> &fe1,
                                           const FiniteElement<dim,spacedim> &fe2,
                                           const unsigned int        subface,
-                                          std_cxx1x::shared_ptr<FullMatrix<double> > &matrix)
+                                          std_cxx11::shared_ptr<FullMatrix<double> > &matrix)
       {
-        if (matrix == std_cxx1x::shared_ptr<FullMatrix<double> >())
+        if (matrix == std_cxx11::shared_ptr<FullMatrix<double> >())
           {
-            matrix = std_cxx1x::shared_ptr<FullMatrix<double> >
+            matrix = std_cxx11::shared_ptr<FullMatrix<double> >
                      (new FullMatrix<double> (fe2.dofs_per_face,
                                               fe1.dofs_per_face));
             fe1.get_subface_interpolation_matrix (fe2,
@@ -376,7 +376,7 @@ namespace DoFTools
       void
       ensure_existence_of_split_face_matrix (const FullMatrix<double> &face_interpolation_matrix,
                                              const std::vector<bool> &master_dof_mask,
-                                             std_cxx1x::shared_ptr<std::pair<FullMatrix<double>,FullMatrix<double> > > &split_matrix)
+                                             std_cxx11::shared_ptr<std::pair<FullMatrix<double>,FullMatrix<double> > > &split_matrix)
       {
         AssertDimension (master_dof_mask.size(), face_interpolation_matrix.m());
         Assert (std::count (master_dof_mask.begin(), master_dof_mask.end(), true) ==
@@ -384,10 +384,10 @@ namespace DoFTools
                 ExcInternalError());
 
         if (split_matrix ==
-            std_cxx1x::shared_ptr<std::pair<FullMatrix<double>,FullMatrix<double> > >())
+            std_cxx11::shared_ptr<std::pair<FullMatrix<double>,FullMatrix<double> > >())
           {
             split_matrix
-              = std_cxx1x::shared_ptr<std::pair<FullMatrix<double>,FullMatrix<double> > >
+              = std_cxx11::shared_ptr<std::pair<FullMatrix<double>,FullMatrix<double> > >
                 (new std::pair<FullMatrix<double>,FullMatrix<double> >());
 
             const unsigned int n_master_dofs = face_interpolation_matrix.n();
@@ -1125,10 +1125,10 @@ namespace DoFTools
       // different (or the same) finite elements. we compute them only
       // once, namely the first time they are needed, and then just reuse
       // them
-      Table<2,std_cxx1x::shared_ptr<FullMatrix<double> > >
+      Table<2,std_cxx11::shared_ptr<FullMatrix<double> > >
       face_interpolation_matrices (n_finite_elements (dof_handler),
                                    n_finite_elements (dof_handler));
-      Table<3,std_cxx1x::shared_ptr<FullMatrix<double> > >
+      Table<3,std_cxx11::shared_ptr<FullMatrix<double> > >
       subface_interpolation_matrices (n_finite_elements (dof_handler),
                                       n_finite_elements (dof_handler),
                                       GeometryInfo<dim>::max_children_per_face);
@@ -1137,14 +1137,14 @@ namespace DoFTools
       // master and slave parts, and for which the master part is inverted.
       // these two matrices are derived from the face interpolation matrix
       // as described in the @ref hp_paper "hp paper"
-      Table<2,std_cxx1x::shared_ptr<std::pair<FullMatrix<double>,FullMatrix<double> > > >
+      Table<2,std_cxx11::shared_ptr<std::pair<FullMatrix<double>,FullMatrix<double> > > >
       split_face_interpolation_matrices (n_finite_elements (dof_handler),
                                          n_finite_elements (dof_handler));
 
       // finally, for each pair of finite elements, have a mask that states
       // which of the degrees of freedom on the coarse side of a refined
       // face will act as master dofs.
-      Table<2,std_cxx1x::shared_ptr<std::vector<bool> > >
+      Table<2,std_cxx11::shared_ptr<std::vector<bool> > >
       master_dof_masks (n_finite_elements (dof_handler),
                         n_finite_elements (dof_handler));
 
@@ -2336,21 +2336,21 @@ namespace DoFTools
 
         WorkStream::run(coarse_grid.begin_active(),
                         coarse_grid.end(),
-                        std_cxx1x::bind(&compute_intergrid_weights_3<dim,spacedim>,
-                                        std_cxx1x::_1,
-                                        std_cxx1x::_2,
-                                        std_cxx1x::_3,
+                        std_cxx11::bind(&compute_intergrid_weights_3<dim,spacedim>,
+                                        std_cxx11::_1,
+                                        std_cxx11::_2,
+                                        std_cxx11::_3,
                                         coarse_component,
-                                        std_cxx1x::cref(coarse_grid.get_fe()),
-                                        std_cxx1x::cref(coarse_to_fine_grid_map),
-                                        std_cxx1x::cref(parameter_dofs),
-                                        std_cxx1x::cref(weight_mapping)),
-                        std_cxx1x::bind(&copy_intergrid_weights_3<dim,spacedim>,
-                                        std_cxx1x::_1,
+                                        std_cxx11::cref(coarse_grid.get_fe()),
+                                        std_cxx11::cref(coarse_to_fine_grid_map),
+                                        std_cxx11::cref(parameter_dofs),
+                                        std_cxx11::cref(weight_mapping)),
+                        std_cxx11::bind(&copy_intergrid_weights_3<dim,spacedim>,
+                                        std_cxx11::_1,
                                         coarse_component,
-                                        std_cxx1x::cref(coarse_grid.get_fe()),
-                                        std_cxx1x::cref(weight_mapping),
-                                        std_cxx1x::ref(weights)),
+                                        std_cxx11::cref(coarse_grid.get_fe()),
+                                        std_cxx11::cref(weight_mapping),
+                                        std_cxx11::ref(weights)),
                         scratch,
                         copy_data);
       }
index f6af894545febfb3683fc6a679ca23e1f7dcbab8..ec357629d0748fc74784340087b50702e4ff36b4 100644 (file)
@@ -1852,7 +1852,7 @@ void FESystem<dim,spacedim>::initialize (const std::vector<const FiniteElement<d
       if (multiplicities[i]>0)
         {
           base_elements[ind] =
-            std::make_pair (std_cxx1x::shared_ptr<const FiniteElement<dim,spacedim> >
+            std::make_pair (std_cxx11::shared_ptr<const FiniteElement<dim,spacedim> >
                             (fes[i]->clone()),
                             multiplicities[i]);
           ++ind;
index ddbb5a05718468c9e8377bfd11f87e2e531132eb..ad53b74c3816226300b118e40f508e3d773d9d21 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -44,7 +44,7 @@
 #include <deal.II/dofs/dof_tools.h>
 #include <deal.II/hp/dof_handler.h>
 
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 
 #include <deal.II/base/index_set.h>
 
@@ -116,9 +116,9 @@ namespace
 
   template <int dim>
   void
-  fill_no_codim_fe_names (std::map<std::string,std_cxx1x::shared_ptr<const Subscriptor> > &result)
+  fill_no_codim_fe_names (std::map<std::string,std_cxx11::shared_ptr<const Subscriptor> > &result)
   {
-    typedef std_cxx1x::shared_ptr<const Subscriptor> FEFactoryPointer;
+    typedef std_cxx11::shared_ptr<const Subscriptor> FEFactoryPointer;
 
     result["FE_Q_Hierarchical"]
       = FEFactoryPointer(new FETools::FEFactory<FE_Q_Hierarchical<dim> >);
@@ -151,9 +151,9 @@ namespace
   // nonzero codimension.
   template <int dim, int spacedim>
   void
-  fill_codim_fe_names (std::map<std::string,std_cxx1x::shared_ptr<const Subscriptor> > &result)
+  fill_codim_fe_names (std::map<std::string,std_cxx11::shared_ptr<const Subscriptor> > &result)
   {
-    typedef std_cxx1x::shared_ptr<const Subscriptor> FEFactoryPointer;
+    typedef std_cxx11::shared_ptr<const Subscriptor> FEFactoryPointer;
 
     result["FE_DGP"]
       = FEFactoryPointer(new FETools::FEFactory<FE_DGP<dim,spacedim> >);
@@ -171,12 +171,12 @@ namespace
   // by the functions above.
   std::vector<std::vector<
   std::map<std::string,
-      std_cxx1x::shared_ptr<const Subscriptor> > > >
+      std_cxx11::shared_ptr<const Subscriptor> > > >
       fill_default_map()
   {
     std::vector<std::vector<
     std::map<std::string,
-        std_cxx1x::shared_ptr<const Subscriptor> > > >
+        std_cxx11::shared_ptr<const Subscriptor> > > >
         result(4);
 
     for (unsigned int d=0; d<4; ++d)
@@ -228,7 +228,7 @@ namespace
   static
   std::vector<std::vector<
   std::map<std::string,
-      std_cxx1x::shared_ptr<const Subscriptor> > > >
+      std_cxx11::shared_ptr<const Subscriptor> > > >
       fe_name_map = fill_default_map();
 }
 
@@ -1307,7 +1307,7 @@ namespace FETools
     // Insert the normalized name into
     // the map
     fe_name_map[dim][spacedim][name] =
-      std_cxx1x::shared_ptr<const Subscriptor> (factory);
+      std_cxx11::shared_ptr<const Subscriptor> (factory);
   }
 
 
@@ -1323,7 +1323,7 @@ namespace FETools
       FiniteElement<dim,spacedim> *
       get_fe_from_name_ext (std::string &name,
                             const std::map<std::string,
-                            std_cxx1x::shared_ptr<const Subscriptor> >
+                            std_cxx11::shared_ptr<const Subscriptor> >
                             &fe_name_map)
       {
         // Extract the name of the
index 13a0dace97e286d2e3cf3c2adc2d706a7f19d6b0..69cfdac3aa2eb65ad6416e822be11573db0f03d3 100644 (file)
@@ -40,7 +40,7 @@
 #include <deal.II/dofs/dof_tools.h>
 #include <deal.II/hp/dof_handler.h>
 
-#include <deal.II/base/std_cxx1x/shared_ptr.h>
+#include <deal.II/base/std_cxx11/shared_ptr.h>
 
 #include <deal.II/base/index_set.h>
 
@@ -117,7 +117,7 @@ namespace FETools
     // that memory is released again
     std::map<const FiniteElement<dim,spacedim> *,
         std::map<const FiniteElement<dim,spacedim> *,
-        std_cxx1x::shared_ptr<FullMatrix<double> > > >
+        std_cxx11::shared_ptr<FullMatrix<double> > > >
         interpolation_matrices;
 
     typename DH1<dim,spacedim>::active_cell_iterator cell1 = dof1.begin_active(),
@@ -177,7 +177,7 @@ namespace FETools
           // there
           if (interpolation_matrices[&cell1->get_fe()][&cell2->get_fe()].get() == 0)
             {
-              std_cxx1x::shared_ptr<FullMatrix<double> >
+              std_cxx11::shared_ptr<FullMatrix<double> >
               interpolation_matrix (new FullMatrix<double> (dofs_per_cell2,
                                                             dofs_per_cell1));
               interpolation_matrices[&cell1->get_fe()][&cell2->get_fe()]
@@ -359,7 +359,7 @@ namespace FETools
     // dof1 to the back_interpolation
     // matrices
     std::map<const FiniteElement<dim> *,
-        std_cxx1x::shared_ptr<FullMatrix<double> > > interpolation_matrices;
+        std_cxx11::shared_ptr<FullMatrix<double> > > interpolation_matrices;
 
     for (; cell!=endc; ++cell)
       if ((cell->subdomain_id() == subdomain_id)
@@ -393,7 +393,7 @@ namespace FETools
           if (interpolation_matrices[&cell->get_fe()] != 0)
             {
               interpolation_matrices[&cell->get_fe()] =
-                std_cxx1x::shared_ptr<FullMatrix<double> >
+                std_cxx11::shared_ptr<FullMatrix<double> >
                 (new FullMatrix<double>(dofs_per_cell1, dofs_per_cell1));
               get_back_interpolation_matrix(dof1.get_fe(), fe2,
                                             *interpolation_matrices[&cell->get_fe()]);
index bc11087217842ad9098ef83eb1893a1dd348381f..3169217a6cde4fcf6929fb158d6bfb28061ec8bf 100644 (file)
@@ -3255,8 +3255,8 @@ maybe_invalidate_previous_present_cell (const typename Triangulation<dim,spacedi
           invalidate_present_cell();
           tria_listener =
             cell->get_triangulation().signals.any_change.connect
-            (std_cxx1x::bind (&FEValuesBase<dim,spacedim>::invalidate_present_cell,
-                              std_cxx1x::ref(static_cast<FEValuesBase<dim,spacedim>&>(*this))));
+            (std_cxx11::bind (&FEValuesBase<dim,spacedim>::invalidate_present_cell,
+                              std_cxx11::ref(static_cast<FEValuesBase<dim,spacedim>&>(*this))));
         }
     }
   else
@@ -3266,8 +3266,8 @@ maybe_invalidate_previous_present_cell (const typename Triangulation<dim,spacedi
       // changes
       tria_listener =
         cell->get_triangulation().signals.post_refinement.connect
-        (std_cxx1x::bind (&FEValuesBase<dim,spacedim>::invalidate_present_cell,
-                          std_cxx1x::ref(static_cast<FEValuesBase<dim,spacedim>&>(*this))));
+        (std_cxx11::bind (&FEValuesBase<dim,spacedim>::invalidate_present_cell,
+                          std_cxx11::ref(static_cast<FEValuesBase<dim,spacedim>&>(*this))));
     }
 }
 
index b54c79c338f4bbfe96aa8c7888ae2a5ce7edf3c0..451a7cd62ac0bcab90c4a5ef66700a7944db5491 100644 (file)
@@ -2469,7 +2469,7 @@ void GridOut::write_vtk (const Triangulation<dim,spacedim> &tria,
   // information, etc.
   DataOutBase::write_vtk (triangulation_to_patches(tria),
                           std::vector<std::string>(),
-                          std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> >(),
+                          std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> >(),
                           vtk_flags,
                           out);
 
@@ -2490,7 +2490,7 @@ void GridOut::write_vtu (const Triangulation<dim,spacedim> &tria,
   // information, etc.
   DataOutBase::write_vtu (triangulation_to_patches(tria),
                           std::vector<std::string>(),
-                          std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> >(),
+                          std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> >(),
                           vtu_flags,
                           out);
 
index 1091387cc54b95d81958f36af6241b32fb3a0452..fd315405567ddb225be8907ca9176a97e8f03398 100644 (file)
@@ -19,7 +19,7 @@
 #include <deal.II/grid/grid_reordering_internal.h>
 #include <deal.II/grid/grid_tools.h>
 #include <deal.II/base/utilities.h>
-#include <deal.II/base/std_cxx1x/bind.h>
+#include <deal.II/base/std_cxx11/bind.h>
 
 #include <algorithm>
 #include <set>
@@ -382,9 +382,9 @@ namespace internal
       std::transform(inquads.begin(),
                      inquads.end(),
                      std::back_inserter(mquads),
-                     std_cxx1x::bind(build_quad_from_vertices,
-                                     std_cxx1x::_1,
-                                     std_cxx1x::cref(sides)) );
+                     std_cxx11::bind(build_quad_from_vertices,
+                                     std_cxx11::_1,
+                                     std_cxx11::cref(sides)) );
 
       // Assign the quads to their sides also.
       int qctr = 0;
index 6689f8a56c1bf6bb16f297a785eba7937e16bef2..f4a7d395870eb68c275eb4430dd9f33bc8f55ab3 100644 (file)
@@ -14,7 +14,7 @@
 //
 // ---------------------------------------------------------------------
 
-#include <deal.II/base/std_cxx1x/array.h>
+#include <deal.II/base/std_cxx11/array.h>
 #include <deal.II/base/quadrature_lib.h>
 #include <deal.II/grid/tria.h>
 #include <deal.II/distributed/tria.h>
@@ -2156,7 +2156,7 @@ next_cell:
 
   template<> struct OrientationLookupTable<1>
   {
-    typedef std_cxx1x::array<unsigned int, GeometryInfo<1>::vertices_per_face> MATCH_T;
+    typedef std_cxx11::array<unsigned int, GeometryInfo<1>::vertices_per_face> MATCH_T;
     static inline std::bitset<3> lookup (const MATCH_T &)
     {
       // The 1D case is trivial
@@ -2166,7 +2166,7 @@ next_cell:
 
   template<> struct OrientationLookupTable<2>
   {
-    typedef std_cxx1x::array<unsigned int, GeometryInfo<2>::vertices_per_face> MATCH_T;
+    typedef std_cxx11::array<unsigned int, GeometryInfo<2>::vertices_per_face> MATCH_T;
     static inline std::bitset<3> lookup (const MATCH_T &matching)
     {
       // In 2D matching faces (=lines) results in two cases: Either
@@ -2187,7 +2187,7 @@ next_cell:
 
   template<> struct OrientationLookupTable<3>
   {
-    typedef std_cxx1x::array<unsigned int, GeometryInfo<3>::vertices_per_face> MATCH_T;
+    typedef std_cxx11::array<unsigned int, GeometryInfo<3>::vertices_per_face> MATCH_T;
     static inline std::bitset<3> lookup (const MATCH_T &matching)
     {
       // The full fledged 3D case. *Yay*
@@ -2232,7 +2232,7 @@ next_cell:
 
     // Do a full matching of the face vertices:
 
-    std_cxx1x::
+    std_cxx11::
     array<unsigned int, GeometryInfo<dim>::vertices_per_face> matching;
 
     std::set<unsigned int> face2_vertices;
index ca640d4ed7831112d20a96cb5e86d112eddadfaa..dd79a43d847b3c84f84a858c7f9125901d186abc 100644 (file)
@@ -18,7 +18,7 @@
 #include <deal.II/base/memory_consumption.h>
 #include <deal.II/base/table.h>
 #include <deal.II/base/geometry_info.h>
-#include <deal.II/base/std_cxx1x/bind.h>
+#include <deal.II/base/std_cxx11/bind.h>
 
 #include <deal.II/grid/tria.h>
 #include <deal.II/grid/tria_levels.h>
@@ -40,7 +40,7 @@
 #include <cmath>
 #include <functional>
 
-#include <deal.II/base/std_cxx1x/array.h>
+#include <deal.II/base/std_cxx11/array.h>
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -2074,7 +2074,7 @@ namespace internal
         // this file
         std::map<internal::Triangulation::TriaObject<2>,
             std::pair<typename Triangulation<dim,spacedim>::quad_iterator,
-            std_cxx1x::array<bool,GeometryInfo<dim>::lines_per_face> >,
+            std_cxx11::array<bool,GeometryInfo<dim>::lines_per_face> >,
             QuadComparator>
             needed_quads;
         for (unsigned int cell=0; cell<cells.size(); ++cell)
@@ -2105,7 +2105,7 @@ namespace internal
             std::pair<int,int> line_list[GeometryInfo<dim>::lines_per_cell],
                 inverse_line_list[GeometryInfo<dim>::lines_per_cell];
             unsigned int face_line_list[GeometryInfo<dim>::lines_per_face];
-            std_cxx1x::array<bool,GeometryInfo<dim>::lines_per_face> orientation;
+            std_cxx11::array<bool,GeometryInfo<dim>::lines_per_face> orientation;
 
             for (unsigned int line=0; line<GeometryInfo<dim>::lines_per_cell; ++line)
               {
@@ -2226,7 +2226,7 @@ namespace internal
           quad = triangulation.begin_raw_quad();
           typename std::map<internal::Triangulation::TriaObject<2>,
                    std::pair<typename Triangulation<dim,spacedim>::quad_iterator,
-                   std_cxx1x::array<bool,GeometryInfo<dim>::lines_per_face> >,
+                   std_cxx11::array<bool,GeometryInfo<dim>::lines_per_face> >,
                    QuadComparator>
                    ::iterator q;
           for (q = needed_quads.begin(); quad!=triangulation.end_quad(); ++quad, ++q)
@@ -13273,22 +13273,22 @@ Triangulation<dim, spacedim>::add_refinement_listener (RefinementListener &liste
   std::vector<boost::signals2::connection> connections;
 
   connections.push_back
-  (signals.create.connect (std_cxx1x::bind (&RefinementListener::create_notification,
-                                            std_cxx1x::ref(listener),
-                                            std_cxx1x::cref(*this))));
+  (signals.create.connect (std_cxx11::bind (&RefinementListener::create_notification,
+                                            std_cxx11::ref(listener),
+                                            std_cxx11::cref(*this))));
   connections.push_back
-  (signals.copy.connect (std_cxx1x::bind (&RefinementListener::copy_notification,
-                                          std_cxx1x::ref(listener),
-                                          std_cxx1x::cref(*this),
-                                          std_cxx1x::_1)));
+  (signals.copy.connect (std_cxx11::bind (&RefinementListener::copy_notification,
+                                          std_cxx11::ref(listener),
+                                          std_cxx11::cref(*this),
+                                          std_cxx11::_1)));
   connections.push_back
-  (signals.pre_refinement.connect (std_cxx1x::bind (&RefinementListener::pre_refinement_notification,
-                                                    std_cxx1x::ref(listener),
-                                                    std_cxx1x::cref(*this))));
+  (signals.pre_refinement.connect (std_cxx11::bind (&RefinementListener::pre_refinement_notification,
+                                                    std_cxx11::ref(listener),
+                                                    std_cxx11::cref(*this))));
   connections.push_back
-  (signals.post_refinement.connect (std_cxx1x::bind (&RefinementListener::post_refinement_notification,
-                                                     std_cxx1x::ref(listener),
-                                                     std_cxx1x::cref(*this))));
+  (signals.post_refinement.connect (std_cxx11::bind (&RefinementListener::post_refinement_notification,
+                                                     std_cxx11::ref(listener),
+                                                     std_cxx11::cref(*this))));
 
   // now push the set of connections into the map
   refinement_listener_map.insert (std::make_pair(&listener, connections));
index 7024425f42ccaf830961b9678c2c4cd00debc493..23f7998da2a13f6c1cb4c71e5e239626855113ca 100644 (file)
@@ -198,7 +198,7 @@ get_line_support_points (const unsigned int n_intermediate_points) const
       // another thread might have created points in the meantime
       if (points[n_intermediate_points].get() == 0)
         {
-          std_cxx1x::shared_ptr<QGaussLobatto<1> >
+          std_cxx11::shared_ptr<QGaussLobatto<1> >
           quadrature (new QGaussLobatto<1>(n_intermediate_points+2));
           points[n_intermediate_points] = quadrature;
         }
index 6467bed38a461a933b9190527986563dae5b83b5..6d735da5726e96b91247f73848b25e4408f40bc9 100644 (file)
@@ -17,7 +17,7 @@
 #include <deal.II/base/memory_consumption.h>
 #include <deal.II/base/geometry_info.h>
 #include <deal.II/base/thread_management.h>
-#include <deal.II/base/std_cxx1x/bind.h>
+#include <deal.II/base/std_cxx11/bind.h>
 #include <deal.II/hp/dof_handler.h>
 #include <deal.II/hp/dof_level.h>
 #include <deal.II/hp/dof_faces.h>
@@ -70,7 +70,7 @@ namespace internal
     void
     ensure_existence_of_dof_identities (const FiniteElement<dim,spacedim> &fe1,
                                         const FiniteElement<dim,spacedim> &fe2,
-                                        std_cxx1x::shared_ptr<DoFIdentities> &identities)
+                                        std_cxx11::shared_ptr<DoFIdentities> &identities)
     {
       // see if we need to fill this
       // entry, or whether it already
@@ -82,7 +82,7 @@ namespace internal
             case 0:
             {
               identities =
-                std_cxx1x::shared_ptr<DoFIdentities>
+                std_cxx11::shared_ptr<DoFIdentities>
                 (new DoFIdentities(fe1.hp_vertex_dof_identities(fe2)));
               break;
             }
@@ -90,7 +90,7 @@ namespace internal
             case 1:
             {
               identities =
-                std_cxx1x::shared_ptr<DoFIdentities>
+                std_cxx11::shared_ptr<DoFIdentities>
                 (new DoFIdentities(fe1.hp_line_dof_identities(fe2)));
               break;
             }
@@ -98,7 +98,7 @@ namespace internal
             case 2:
             {
               identities =
-                std_cxx1x::shared_ptr<DoFIdentities>
+                std_cxx11::shared_ptr<DoFIdentities>
                 (new DoFIdentities(fe1.hp_quad_dof_identities(fe2)));
               break;
             }
@@ -1653,16 +1653,16 @@ namespace hp
 
     tria_listeners.push_back
     (tria.signals.pre_refinement
-     .connect (std_cxx1x::bind (&DoFHandler<dim,spacedim>::pre_refinement_action,
-                                std_cxx1x::ref(*this))));
+     .connect (std_cxx11::bind (&DoFHandler<dim,spacedim>::pre_refinement_action,
+                                std_cxx11::ref(*this))));
     tria_listeners.push_back
     (tria.signals.post_refinement
-     .connect (std_cxx1x::bind (&DoFHandler<dim,spacedim>::post_refinement_action,
-                                std_cxx1x::ref(*this))));
+     .connect (std_cxx11::bind (&DoFHandler<dim,spacedim>::post_refinement_action,
+                                std_cxx11::ref(*this))));
     tria_listeners.push_back
     (tria.signals.create
-     .connect (std_cxx1x::bind (&DoFHandler<dim,spacedim>::post_refinement_action,
-                                std_cxx1x::ref(*this))));
+     .connect (std_cxx11::bind (&DoFHandler<dim,spacedim>::post_refinement_action,
+                                std_cxx11::ref(*this))));
   }
 
 
@@ -2109,7 +2109,7 @@ namespace hp
     // vertices at all, I can't think
     // of a finite element that would
     // make that necessary...
-    Table<2,std_cxx1x::shared_ptr<dealii::internal::hp::DoFIdentities> >
+    Table<2,std_cxx11::shared_ptr<dealii::internal::hp::DoFIdentities> >
     vertex_dof_identities (get_fe().size(),
                            get_fe().size());
 
@@ -2275,7 +2275,7 @@ namespace hp
     // and then only deal with those that are
     // not identical of which we can handle
     // at most 2
-    Table<2,std_cxx1x::shared_ptr<internal::hp::DoFIdentities> >
+    Table<2,std_cxx11::shared_ptr<internal::hp::DoFIdentities> >
     line_dof_identities (finite_elements->size(),
                          finite_elements->size());
 
@@ -2509,7 +2509,7 @@ namespace hp
     // for quads only in 4d and
     // higher, so this isn't a
     // particularly frequent case
-    Table<2,std_cxx1x::shared_ptr<internal::hp::DoFIdentities> >
+    Table<2,std_cxx11::shared_ptr<internal::hp::DoFIdentities> >
     quad_dof_identities (finite_elements->size(),
                          finite_elements->size());
 
index 834140145b8f92d49e4a78a60b3bd43868d689ba..c0a814d269bdcb801c42b1dabc7c2b977ddd1dea 100644 (file)
@@ -71,7 +71,7 @@ namespace hp
                           "same number of vector components!"));
 
     finite_elements
-    .push_back (std_cxx1x::shared_ptr<const FiniteElement<dim,spacedim> >(new_fe.clone()));
+    .push_back (std_cxx11::shared_ptr<const FiniteElement<dim,spacedim> >(new_fe.clone()));
   }
 
 
index 782c3595d1362cbe758d92b1bb3ebf6c9573690f..f430a9647bc2bf68bcf63a676b1f08b8c12b8f41 100644 (file)
@@ -95,7 +95,7 @@ namespace internal
       if (fe_values_table(present_fe_values_index).get() == 0)
         fe_values_table(present_fe_values_index)
           =
-            std_cxx1x::shared_ptr<FEValues>
+            std_cxx11::shared_ptr<FEValues>
             (new FEValues ((*mapping_collection)[mapping_index],
                            (*fe_collection)[fe_index],
                            q_collection[q_index],
index 06f111fdcf5e45af09312b52693ff91eac3c4ae3..77878ab51746120cc43a52ba5919208b7c6d3df5 100644 (file)
@@ -35,7 +35,7 @@ namespace hp
   MappingCollection (const Mapping<dim,spacedim> &mapping)
   {
     mappings
-    .push_back (std_cxx1x::shared_ptr<const Mapping<dim,spacedim> >(mapping.clone()));
+    .push_back (std_cxx11::shared_ptr<const Mapping<dim,spacedim> >(mapping.clone()));
   }
 
 
@@ -76,7 +76,7 @@ namespace hp
   MappingCollection<dim,spacedim>::push_back (const Mapping<dim,spacedim> &new_mapping)
   {
     mappings
-    .push_back (std_cxx1x::shared_ptr<const Mapping<dim,spacedim> >(new_mapping.clone()));
+    .push_back (std_cxx11::shared_ptr<const Mapping<dim,spacedim> >(new_mapping.clone()));
   }
 
 //---------------------------------------------------------------------------
index b902f5b12c8dd4a9d4a3165b632e7050bdb2004e..587483a02afc17b7b64d3af4585cf7884ceca0ca 100644 (file)
@@ -529,7 +529,7 @@ namespace TrilinosWrappers
     // that tells how the domain dofs of the matrix will be distributed). for
     // only one processor, we can directly assign the columns as well. Compare
     // this with bug # 4123 in the Sandia Bugzilla.
-    std_cxx1x::shared_ptr<Epetra_CrsGraph> graph;
+    std_cxx11::shared_ptr<Epetra_CrsGraph> graph;
     if (input_row_map.Comm().NumProc() > 1)
       graph.reset (new Epetra_CrsGraph (Copy, input_row_map,
                                         &n_entries_per_row[0], true));
@@ -656,7 +656,7 @@ namespace TrilinosWrappers
     Epetra_Map off_processor_map(-1, ghost_rows.size(), &ghost_rows[0],
                                  0, input_row_map.Comm());
 
-    std_cxx1x::shared_ptr<Epetra_CrsGraph> graph, nonlocal_graph;
+    std_cxx11::shared_ptr<Epetra_CrsGraph> graph, nonlocal_graph;
     if (input_row_map.Comm().NumProc() > 1)
       {
         graph.reset (new Epetra_CrsGraph (Copy, input_row_map,
index 4bad57a8a6296a43986e64992266a54d94ed2830..261e2560ed679c51fd984e9db987a4ffa49e1fa2 100644 (file)
@@ -309,7 +309,7 @@ namespace TrilinosWrappers
       Epetra_Map new_map (v.size(), n_elements, &global_ids[0], 0,
                           v.block(0).vector_partitioner().Comm());
 
-      std_cxx1x::shared_ptr<Epetra_FEVector> actual_vec;
+      std_cxx11::shared_ptr<Epetra_FEVector> actual_vec;
       if ( import_data == true )
         actual_vec.reset (new Epetra_FEVector (new_map));
       else
index 35442b79a0fcf656bf32de0f09954e7010b58089..681b65c6df63b9aaa56019c08dffc9401f2d0a19 100644 (file)
@@ -291,9 +291,9 @@ void MGTransferBlockBase::build_matrices (
   for (unsigned int i=0; i<n_levels-1; ++i)
     {
       prolongation_sparsities
-      .push_back (std_cxx1x::shared_ptr<BlockSparsityPattern> (new BlockSparsityPattern));
+      .push_back (std_cxx11::shared_ptr<BlockSparsityPattern> (new BlockSparsityPattern));
       prolongation_matrices
-      .push_back (std_cxx1x::shared_ptr<BlockSparseMatrix<double> > (new BlockSparseMatrix<double>));
+      .push_back (std_cxx11::shared_ptr<BlockSparseMatrix<double> > (new BlockSparseMatrix<double>));
     }
 
   // two fields which will store the
index 1be8a299e6ccf5546374a305c9fd5ff22e581ff8..ffc8fa04e2b3eeaefdbda6bf20997bb7adada231 100644 (file)
@@ -387,9 +387,9 @@ void MGTransferComponentBase::build_matrices (
   for (unsigned int i=0; i<n_levels-1; ++i)
     {
       prolongation_sparsities
-      .push_back (std_cxx1x::shared_ptr<BlockSparsityPattern> (new BlockSparsityPattern));
+      .push_back (std_cxx11::shared_ptr<BlockSparsityPattern> (new BlockSparsityPattern));
       prolongation_matrices
-      .push_back (std_cxx1x::shared_ptr<BlockSparseMatrix<double> > (new BlockSparseMatrix<double>));
+      .push_back (std_cxx11::shared_ptr<BlockSparseMatrix<double> > (new BlockSparseMatrix<double>));
     }
 
   // two fields which will store the
index f19388ce34a73862a154cbc6bd3602c0c111f37b..9b97b918962c0e7d00dab97c3849e51e19161a66 100644 (file)
@@ -141,9 +141,9 @@ void MGTransferPrebuilt<VECTOR>::build_matrices (
   for (unsigned int i=0; i<n_levels-1; ++i)
     {
       prolongation_sparsities.push_back
-      (std_cxx1x::shared_ptr<typename internal::MatrixSelector<VECTOR>::Sparsity> (new typename internal::MatrixSelector<VECTOR>::Sparsity));
+      (std_cxx11::shared_ptr<typename internal::MatrixSelector<VECTOR>::Sparsity> (new typename internal::MatrixSelector<VECTOR>::Sparsity));
       prolongation_matrices.push_back
-      (std_cxx1x::shared_ptr<typename internal::MatrixSelector<VECTOR>::Matrix> (new typename internal::MatrixSelector<VECTOR>::Matrix));
+      (std_cxx11::shared_ptr<typename internal::MatrixSelector<VECTOR>::Matrix> (new typename internal::MatrixSelector<VECTOR>::Matrix));
     }
 
   // two fields which will store the
index 2249bfc7062e0f1d4a0d43d41514730b810298d8..5f1c39832ad11304202e9520c314b4b58a6119c3 100644 (file)
@@ -42,7 +42,7 @@ namespace internal
                   const unsigned int n_subdivisions,
                   const std::vector<unsigned int> &n_postprocessor_outputs,
                   const Mapping<dim,spacedim> &mapping,
-                  const std::vector<std_cxx1x::shared_ptr<dealii::hp::FECollection<dim,spacedim> > > &finite_elements,
+                  const std::vector<std_cxx11::shared_ptr<dealii::hp::FECollection<dim,spacedim> > > &finite_elements,
                   const UpdateFlags update_flags,
                   const std::vector<std::vector<unsigned int> > &cell_to_patch_index_map)
       :
@@ -448,11 +448,11 @@ void DataOut<dim,DH>::build_patches (const Mapping<DH::dimension,DH::space_dimen
   if (all_cells.size() > 0)
     WorkStream::run (&all_cells[0],
                      &all_cells[0]+all_cells.size(),
-                     std_cxx1x::bind(&DataOut<dim,DH>::build_one_patch,
-                                     this, std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3,
-                                     curved_cell_region,std_cxx1x::ref(this->patches)),
+                     std_cxx11::bind(&DataOut<dim,DH>::build_one_patch,
+                                     this, std_cxx11::_1, std_cxx11::_2, std_cxx11::_3,
+                                     curved_cell_region,std_cxx11::ref(this->patches)),
                      // no copy-local-to-global function needed here
-                     std_cxx1x::function<void (const ::dealii::DataOutBase::Patch<DH::dimension, DH::space_dimension> &)>(),
+                     std_cxx11::function<void (const ::dealii::DataOutBase::Patch<DH::dimension, DH::space_dimension> &)>(),
                      thread_data,
                      sample_patch,
                      // experimenting shows that we can make things run a bit
index 50e8bce2162a023de64a5b30be3739bb3f6f3086..9b3cb62889b2897ceb13ffd8149bd8b487a3b478 100644 (file)
@@ -53,7 +53,7 @@ namespace internal
                       const unsigned int n_subdivisions,
                       const std::vector<unsigned int> &n_postprocessor_outputs,
                       const Mapping<dim,spacedim> &mapping,
-                      const std::vector<std_cxx1x::shared_ptr<dealii::hp::FECollection<dim,spacedim> > > &finite_elements,
+                      const std::vector<std_cxx11::shared_ptr<dealii::hp::FECollection<dim,spacedim> > > &finite_elements,
                       const UpdateFlags update_flags,
                       const bool        use_face_values)
       :
@@ -210,7 +210,7 @@ namespace internal
     template <typename DH>
     void
     ParallelDataBase<dim,spacedim>::
-    reinit_all_fe_values(std::vector<std_cxx1x::shared_ptr<DataEntryBase<DH> > > &dof_data,
+    reinit_all_fe_values(std::vector<std_cxx11::shared_ptr<DataEntryBase<DH> > > &dof_data,
                          const typename dealii::Triangulation<dim,spacedim>::cell_iterator &cell,
                          const unsigned int face)
     {
@@ -780,9 +780,9 @@ add_data_vector (const VECTOR                             &vec,
     = new internal::DataOut::DataEntry<DH,VECTOR>(dofs, &vec, names,
                                                   data_component_interpretation);
   if (actual_type == type_dof_data)
-    dof_data.push_back (std_cxx1x::shared_ptr<internal::DataOut::DataEntryBase<DH> >(new_entry));
+    dof_data.push_back (std_cxx11::shared_ptr<internal::DataOut::DataEntryBase<DH> >(new_entry));
   else
-    cell_data.push_back (std_cxx1x::shared_ptr<internal::DataOut::DataEntryBase<DH> >(new_entry));
+    cell_data.push_back (std_cxx11::shared_ptr<internal::DataOut::DataEntryBase<DH> >(new_entry));
 }
 
 
@@ -809,7 +809,7 @@ add_data_vector (const VECTOR                           &vec,
 
   internal::DataOut::DataEntryBase<DH> *new_entry
     = new internal::DataOut::DataEntry<DH,VECTOR>(dofs, &vec, &data_postprocessor);
-  dof_data.push_back (std_cxx1x::shared_ptr<internal::DataOut::DataEntryBase<DH> >(new_entry));
+  dof_data.push_back (std_cxx11::shared_ptr<internal::DataOut::DataEntryBase<DH> >(new_entry));
 }
 
 
@@ -832,7 +832,7 @@ add_data_vector (const DH                               &dof_handler,
 
   internal::DataOut::DataEntryBase<DH> *new_entry
     = new internal::DataOut::DataEntry<DH,VECTOR>(&dof_handler, &vec, &data_postprocessor);
-  dof_data.push_back (std_cxx1x::shared_ptr<internal::DataOut::DataEntryBase<DH> >(new_entry));
+  dof_data.push_back (std_cxx11::shared_ptr<internal::DataOut::DataEntryBase<DH> >(new_entry));
 }
 
 
@@ -905,7 +905,7 @@ add_data_vector (const DH                       &dof_handler,
   internal::DataOut::DataEntryBase<DH> *new_entry
     = new internal::DataOut::DataEntry<DH,VECTOR>(&dof_handler, &data, names,
                                                   data_component_interpretation);
-  dof_data.push_back (std_cxx1x::shared_ptr<internal::DataOut::DataEntryBase<DH> >(new_entry));
+  dof_data.push_back (std_cxx11::shared_ptr<internal::DataOut::DataEntryBase<DH> >(new_entry));
 }
 
 
@@ -970,7 +970,7 @@ get_dataset_names () const
   // collect the names of dof
   // and cell data
   typedef
-  typename std::vector<std_cxx1x::shared_ptr<internal::DataOut::DataEntryBase<DH> > >::const_iterator
+  typename std::vector<std_cxx11::shared_ptr<internal::DataOut::DataEntryBase<DH> > >::const_iterator
   data_iterator;
 
   for (data_iterator  d=dof_data.begin();
@@ -990,16 +990,16 @@ get_dataset_names () const
 
 template <class DH,
           int patch_dim, int patch_space_dim>
-std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> >
+std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> >
 DataOut_DoFData<DH,patch_dim,patch_space_dim>::get_vector_data_ranges () const
 {
-  std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> >
+  std::vector<std_cxx11::tuple<unsigned int, unsigned int, std::string> >
   ranges;
 
   // collect the ranges of dof
   // and cell data
   typedef
-  typename std::vector<std_cxx1x::shared_ptr<internal::DataOut::DataEntryBase<DH> > >::const_iterator
+  typename std::vector<std_cxx11::shared_ptr<internal::DataOut::DataEntryBase<DH> > >::const_iterator
   data_iterator;
 
   unsigned int output_component = 0;
@@ -1045,7 +1045,7 @@ DataOut_DoFData<DH,patch_dim,patch_space_dim>::get_vector_data_ranges () const
 
           // finally add a corresponding
           // range
-          std_cxx1x::tuple<unsigned int, unsigned int, std::string>
+          std_cxx11::tuple<unsigned int, unsigned int, std::string>
           range (output_component,
                  output_component+patch_space_dim-1,
                  name);
@@ -1094,12 +1094,12 @@ DataOut_DoFData<DH,patch_dim,patch_space_dim>::get_patches () const
 
 template <class DH,
           int patch_dim, int patch_space_dim>
-std::vector<std_cxx1x::shared_ptr<dealii::hp::FECollection<DH::dimension,DH::space_dimension> > >
+std::vector<std_cxx11::shared_ptr<dealii::hp::FECollection<DH::dimension,DH::space_dimension> > >
 DataOut_DoFData<DH,patch_dim,patch_space_dim>::get_finite_elements() const
 {
   const unsigned int dhdim = DH::dimension;
   const unsigned int dhspacedim = DH::space_dimension;
-  std::vector<std_cxx1x::shared_ptr<dealii::hp::FECollection<dhdim,dhspacedim> > >
+  std::vector<std_cxx11::shared_ptr<dealii::hp::FECollection<dhdim,dhspacedim> > >
   finite_elements(this->dof_data.size());
   for (unsigned int i=0; i<this->dof_data.size(); ++i)
     {
index ea420b3519074833d292475919a813a26f0075b6..c3ef3292dbf4d8e7c0b87afecf0a043db8c8c135 100644 (file)
@@ -422,7 +422,7 @@ for (DH : DOFHANDLER_TEMPLATES; deal_II_dimension : DIMENSIONS; deal_II_space_di
       void
       ParallelDataBase<deal_II_dimension,deal_II_space_dimension>::
       reinit_all_fe_values<dealii::DH<deal_II_dimension,deal_II_space_dimension> >
-      (std::vector<std_cxx1x::shared_ptr<DataEntryBase<dealii::DH<deal_II_dimension,deal_II_space_dimension> > > > &dof_data,
+      (std::vector<std_cxx11::shared_ptr<DataEntryBase<dealii::DH<deal_II_dimension,deal_II_space_dimension> > > > &dof_data,
        const dealii::Triangulation<deal_II_dimension,deal_II_space_dimension>::cell_iterator &cell,
        const unsigned int face);
 #endif
index 992839c74183c6b9cf21f2bedc8f9100a9e6b8b5..2b7c8b3b43c97dd219d76dce40349b3c431a5d7b 100644 (file)
@@ -41,7 +41,7 @@ namespace internal
                   const unsigned int n_subdivisions,
                   const std::vector<unsigned int> &n_postprocessor_outputs,
                   const Mapping<dim,spacedim> &mapping,
-                  const std::vector<std_cxx1x::shared_ptr<dealii::hp::FECollection<dim,spacedim> > > &finite_elements,
+                  const std::vector<std_cxx11::shared_ptr<dealii::hp::FECollection<dim,spacedim> > > &finite_elements,
                   const UpdateFlags update_flags)
       :
       internal::DataOut::
@@ -334,11 +334,11 @@ void DataOutFaces<dim,DH>::build_patches (const Mapping<dimension> &mapping,
   // now build the patches in parallel
   WorkStream::run (&all_faces[0],
                    &all_faces[0]+all_faces.size(),
-                   std_cxx1x::bind(&DataOutFaces<dim,DH>::build_one_patch,
-                                   this, std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3),
-                   std_cxx1x::bind(&internal::DataOutFaces::
+                   std_cxx11::bind(&DataOutFaces<dim,DH>::build_one_patch,
+                                   this, std_cxx11::_1, std_cxx11::_2, std_cxx11::_3),
+                   std_cxx11::bind(&internal::DataOutFaces::
                                    append_patch_to_list<dim,space_dimension>,
-                                   std_cxx1x::_1, std_cxx1x::ref(this->patches)),
+                                   std_cxx11::_1, std_cxx11::ref(this->patches)),
                    thread_data,
                    sample_patch);
 }
index 98d7c51cd47a803fa522ab91ac2121fa6fab9d1d..efe34a46f0be9dfcf19b20a72caa952d268beaa6 100644 (file)
@@ -55,7 +55,7 @@ namespace internal
                   const unsigned int n_patches_per_circle,
                   const std::vector<unsigned int> &n_postprocessor_outputs,
                   const Mapping<dim,spacedim> &mapping,
-                  const std::vector<std_cxx1x::shared_ptr<dealii::hp::FECollection<dim,spacedim> > > &finite_elements,
+                  const std::vector<std_cxx11::shared_ptr<dealii::hp::FECollection<dim,spacedim> > > &finite_elements,
                   const UpdateFlags update_flags)
       :
       internal::DataOut::
@@ -473,11 +473,11 @@ void DataOutRotation<dim,DH>::build_patches (const unsigned int n_patches_per_ci
   // now build the patches in parallel
   WorkStream::run (&all_cells[0],
                    &all_cells[0]+all_cells.size(),
-                   std_cxx1x::bind(&DataOutRotation<dim,DH>::build_one_patch,
-                                   this, std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3),
-                   std_cxx1x::bind(&internal::DataOutRotation
+                   std_cxx11::bind(&DataOutRotation<dim,DH>::build_one_patch,
+                                   this, std_cxx11::_1, std_cxx11::_2, std_cxx11::_3),
+                   std_cxx11::bind(&internal::DataOutRotation
                                    ::append_patch_to_list<dim,space_dimension>,
-                                   std_cxx1x::_1, std_cxx1x::ref(this->patches)),
+                                   std_cxx11::_1, std_cxx11::ref(this->patches)),
                    thread_data,
                    new_patches);
 }
index 93970e636b1152d0145be8681d79a2ee97b62193..044d12e5ed0d28defb2220fd5e33ab02ca59743d 100644 (file)
@@ -930,25 +930,25 @@ namespace DerivativeApproximation
     template <class DerivativeDescription, int dim,
               template <int, int> class DH, class InputVector, int spacedim>
     void
-    approximate (SynchronousIterators<std_cxx1x::tuple<typename DH<dim,spacedim>::active_cell_iterator,Vector<float>::iterator> > const &cell,
+    approximate (SynchronousIterators<std_cxx11::tuple<typename DH<dim,spacedim>::active_cell_iterator,Vector<float>::iterator> > const &cell,
                  const Mapping<dim,spacedim>                  &mapping,
                  const DH<dim,spacedim>                       &dof_handler,
                  const InputVector                            &solution,
                  const unsigned int                            component)
     {
       // if the cell is not locally owned, then there is nothing to do
-      if (std_cxx1x::get<0>(cell.iterators)->is_locally_owned() == false)
-        *std_cxx1x::get<1>(cell.iterators) = 0;
+      if (std_cxx11::get<0>(cell.iterators)->is_locally_owned() == false)
+        *std_cxx11::get<1>(cell.iterators) = 0;
       else
         {
           typename DerivativeDescription::Derivative derivative;
           // call the function doing the actual
           // work on this cell
           approximate_cell<DerivativeDescription,dim,DH,InputVector>
-          (mapping,dof_handler,solution,component,std_cxx1x::get<0>(cell.iterators),derivative);
+          (mapping,dof_handler,solution,component,std_cxx11::get<0>(cell.iterators),derivative);
           // evaluate the norm and fill the vector
           //*derivative_norm_on_this_cell
-          *std_cxx1x::get<1>(cell.iterators) = DerivativeDescription::derivative_norm (derivative);
+          *std_cxx11::get<1>(cell.iterators) = DerivativeDescription::derivative_norm (derivative);
         }
     }
 
@@ -978,7 +978,7 @@ namespace DerivativeApproximation
       Assert (component < dof_handler.get_fe().n_components(),
               ExcIndexRange (component, 0, dof_handler.get_fe().n_components()));
 
-      typedef std_cxx1x::tuple<typename DH<dim,spacedim>::active_cell_iterator,Vector<float>::iterator>
+      typedef std_cxx11::tuple<typename DH<dim,spacedim>::active_cell_iterator,Vector<float>::iterator>
       Iterators;
       SynchronousIterators<Iterators> begin(Iterators(dof_handler.begin_active(),
                                                       derivative_norm.begin())),
@@ -989,14 +989,14 @@ namespace DerivativeApproximation
       // to write in derivative_norm. Scratch and CopyData are also useless.
       WorkStream::run(begin,
                       end,
-                      static_cast<std_cxx1x::function<void (SynchronousIterators<Iterators> const &,
+                      static_cast<std_cxx11::function<void (SynchronousIterators<Iterators> const &,
                                                             Assembler::Scratch const &, Assembler::CopyData &)> >
-                      (std_cxx1x::bind(&approximate<DerivativeDescription,dim,DH,InputVector,spacedim>,
-                                       std_cxx1x::_1,
-                                       std_cxx1x::cref(mapping),
-                                       std_cxx1x::cref(dof_handler),
-                                       std_cxx1x::cref(solution),component)),
-                      std_cxx1x::function<void (internal::Assembler::CopyData const &)> (),
+                      (std_cxx11::bind(&approximate<DerivativeDescription,dim,DH,InputVector,spacedim>,
+                                       std_cxx11::_1,
+                                       std_cxx11::cref(mapping),
+                                       std_cxx11::cref(dof_handler),
+                                       std_cxx11::cref(solution),component)),
+                      std_cxx11::function<void (internal::Assembler::CopyData const &)> (),
                       internal::Assembler::Scratch (),internal::Assembler::CopyData ());
     }
 
index 19fbf0c5427f9f5813358ba0e906a2038164eab3..d6a1c986b5c04821157f989286aa85edacba525f 100644 (file)
@@ -39,7 +39,7 @@
 #include <deal.II/hp/mapping_collection.h>
 #include <deal.II/numerics/error_estimator.h>
 
-#include <deal.II/base/std_cxx1x/bind.h>
+#include <deal.II/base/std_cxx11/bind.h>
 
 #include <numeric>
 #include <algorithm>
@@ -978,10 +978,10 @@ estimate (const Mapping<dim, spacedim>                  &mapping,
   // now let's work on all those cells:
   WorkStream::run (dof_handler.begin_active(),
                    static_cast<typename DH::active_cell_iterator>(dof_handler.end()),
-                   std_cxx1x::bind (&internal::estimate_one_cell<InputVector,DH>,
-                                    std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::ref(solutions)),
-                   std_cxx1x::bind (&internal::copy_local_to_global<DH>,
-                                    std_cxx1x::_1, std_cxx1x::ref(face_integrals)),
+                   std_cxx11::bind (&internal::estimate_one_cell<InputVector,DH>,
+                                    std_cxx11::_1, std_cxx11::_2, std_cxx11::_3, std_cxx11::ref(solutions)),
+                   std_cxx11::bind (&internal::copy_local_to_global<DH>,
+                                    std_cxx11::_1, std_cxx11::ref(face_integrals)),
                    parallel_data,
                    sample_local_face_integrals);
 
index d46e35f25d3489a91bb5f2c6af348f37a73832df..0e37e2eb9619efeb90307bf289f4739b6483bcf8 100644 (file)
@@ -39,7 +39,7 @@
 #include <deal.II/hp/mapping_collection.h>
 #include <deal.II/numerics/error_estimator.h>
 
-#include <deal.II/base/std_cxx1x/bind.h>
+#include <deal.II/base/std_cxx11/bind.h>
 
 #include <numeric>
 #include <algorithm>
index a81921da4adf79a9d23eb8e60e1a205819cde5e5..a24fc83867c855c4a6f2ed81d6f12801a9842f00 100644 (file)
@@ -676,9 +676,9 @@ namespace MatrixCreator
     WorkStream::run (dof.begin_active(),
                      static_cast<typename DoFHandler<dim,spacedim>::active_cell_iterator>(dof.end()),
                      &MatrixCreator::internal::mass_assembler<dim, spacedim, typename DoFHandler<dim,spacedim>::active_cell_iterator>,
-                     std_cxx1x::bind (&MatrixCreator::internal::
+                     std_cxx11::bind (&MatrixCreator::internal::
                                       copy_local_to_global<SparseMatrix<number>, Vector<double> >,
-                                      std_cxx1x::_1, &matrix, (Vector<double> *)0),
+                                      std_cxx11::_1, &matrix, (Vector<double> *)0),
                      assembler_data,
                      copy_data);
   }
@@ -732,9 +732,9 @@ namespace MatrixCreator
     WorkStream::run (dof.begin_active(),
                      static_cast<typename DoFHandler<dim,spacedim>::active_cell_iterator>(dof.end()),
                      &MatrixCreator::internal::mass_assembler<dim, spacedim, typename DoFHandler<dim,spacedim>::active_cell_iterator>,
-                     std_cxx1x::bind(&MatrixCreator::internal::
+                     std_cxx11::bind(&MatrixCreator::internal::
                                      copy_local_to_global<SparseMatrix<number>, Vector<double> >,
-                                     std_cxx1x::_1, &matrix, &rhs_vector),
+                                     std_cxx11::_1, &matrix, &rhs_vector),
                      assembler_data,
                      copy_data);
   }
@@ -786,9 +786,9 @@ namespace MatrixCreator
     WorkStream::run (dof.begin_active(),
                      static_cast<typename hp::DoFHandler<dim,spacedim>::active_cell_iterator>(dof.end()),
                      &MatrixCreator::internal::mass_assembler<dim, spacedim, typename hp::DoFHandler<dim,spacedim>::active_cell_iterator>,
-                     std_cxx1x::bind (&MatrixCreator::internal::
+                     std_cxx11::bind (&MatrixCreator::internal::
                                       copy_local_to_global<SparseMatrix<number>, Vector<double> >,
-                                      std_cxx1x::_1, &matrix, (Vector<double> *)0),
+                                      std_cxx11::_1, &matrix, (Vector<double> *)0),
                      assembler_data,
                      copy_data);
   }
@@ -839,9 +839,9 @@ namespace MatrixCreator
     WorkStream::run (dof.begin_active(),
                      static_cast<typename hp::DoFHandler<dim,spacedim>::active_cell_iterator>(dof.end()),
                      &MatrixCreator::internal::mass_assembler<dim, spacedim, typename hp::DoFHandler<dim,spacedim>::active_cell_iterator>,
-                     std_cxx1x::bind (&MatrixCreator::internal::
+                     std_cxx11::bind (&MatrixCreator::internal::
                                       copy_local_to_global<SparseMatrix<number>, Vector<double> >,
-                                      std_cxx1x::_1, &matrix, &rhs_vector),
+                                      std_cxx11::_1, &matrix, &rhs_vector),
                      assembler_data,
                      copy_data);
   }
@@ -1204,22 +1204,22 @@ namespace MatrixCreator
     MatrixCreator::internal::AssemblerBoundary::CopyData<DoFHandler<dim,spacedim> > copy_data;
 
     WorkStream::run(dof.begin_active(),dof.end(),
-                    static_cast<std_cxx1x::function<void (typename DoFHandler<dim,spacedim>::active_cell_iterator
+                    static_cast<std_cxx11::function<void (typename DoFHandler<dim,spacedim>::active_cell_iterator
                                                           const &,MatrixCreator::internal::AssemblerBoundary::Scratch const &,
                                                           MatrixCreator::internal::AssemblerBoundary::CopyData<DoFHandler<dim,spacedim> > &)> >
-                    (std_cxx1x::bind(&create_boundary_mass_matrix_1<dim,spacedim>,std_cxx1x::_1,std_cxx1x::_2,
-                                     std_cxx1x::_3,
-                                     std_cxx1x::cref(mapping),std_cxx1x::cref(fe),std_cxx1x::cref(q),
-                                     std_cxx1x::cref(boundary_functions),coefficient,
-                                     std_cxx1x::cref(component_mapping))),
-                    static_cast<std_cxx1x::function<void (MatrixCreator::internal::AssemblerBoundary
-                                                          ::CopyData<DoFHandler<dim,spacedim> > const &)> > (std_cxx1x::bind(
+                    (std_cxx11::bind(&create_boundary_mass_matrix_1<dim,spacedim>,std_cxx11::_1,std_cxx11::_2,
+                                     std_cxx11::_3,
+                                     std_cxx11::cref(mapping),std_cxx11::cref(fe),std_cxx11::cref(q),
+                                     std_cxx11::cref(boundary_functions),coefficient,
+                                     std_cxx11::cref(component_mapping))),
+                    static_cast<std_cxx11::function<void (MatrixCreator::internal::AssemblerBoundary
+                                                          ::CopyData<DoFHandler<dim,spacedim> > const &)> > (std_cxx11::bind(
                                                                 &copy_boundary_mass_matrix_1<dim,spacedim>,
-                                                                std_cxx1x::_1,
-                                                                std_cxx1x::cref(boundary_functions),
-                                                                std_cxx1x::cref(dof_to_boundary_mapping),
-                                                                std_cxx1x::ref(matrix),
-                                                                std_cxx1x::ref(rhs_vector))),
+                                                                std_cxx11::_1,
+                                                                std_cxx11::cref(boundary_functions),
+                                                                std_cxx11::cref(dof_to_boundary_mapping),
+                                                                std_cxx11::ref(matrix),
+                                                                std_cxx11::ref(rhs_vector))),
                     scratch,
                     copy_data);
   }
@@ -1619,22 +1619,22 @@ namespace MatrixCreator
     MatrixCreator::internal::AssemblerBoundary::CopyData<hp::DoFHandler<dim,spacedim> > copy_data;
 
     WorkStream::run(dof.begin_active(),dof.end(),
-                    static_cast<std_cxx1x::function<void (typename hp::DoFHandler<dim,spacedim>::active_cell_iterator
+                    static_cast<std_cxx11::function<void (typename hp::DoFHandler<dim,spacedim>::active_cell_iterator
                                                           const &,MatrixCreator::internal::AssemblerBoundary::Scratch const &,
                                                           MatrixCreator::internal::AssemblerBoundary::CopyData<hp::DoFHandler<dim,spacedim> > &)> >
-                    (std_cxx1x::bind( &create_hp_boundary_mass_matrix_1<dim,spacedim>,std_cxx1x::_1,std_cxx1x::_2,
-                                      std_cxx1x::_3,
-                                      std_cxx1x::cref(mapping),std_cxx1x::cref(fe_collection),std_cxx1x::cref(q),
-                                      std_cxx1x::cref(boundary_functions),coefficient,
-                                      std_cxx1x::cref(component_mapping))),
-                    static_cast<std_cxx1x::function<void (MatrixCreator::internal::AssemblerBoundary
+                    (std_cxx11::bind( &create_hp_boundary_mass_matrix_1<dim,spacedim>,std_cxx11::_1,std_cxx11::_2,
+                                      std_cxx11::_3,
+                                      std_cxx11::cref(mapping),std_cxx11::cref(fe_collection),std_cxx11::cref(q),
+                                      std_cxx11::cref(boundary_functions),coefficient,
+                                      std_cxx11::cref(component_mapping))),
+                    static_cast<std_cxx11::function<void (MatrixCreator::internal::AssemblerBoundary
                                                           ::CopyData<hp::DoFHandler<dim,spacedim> > const &)> > (
-                      std_cxx1x::bind( &copy_hp_boundary_mass_matrix_1<dim,spacedim>,
-                                       std_cxx1x::_1,
-                                       std_cxx1x::cref(boundary_functions),
-                                       std_cxx1x::cref(dof_to_boundary_mapping),
-                                       std_cxx1x::ref(matrix),
-                                       std_cxx1x::ref(rhs_vector))),
+                      std_cxx11::bind( &copy_hp_boundary_mass_matrix_1<dim,spacedim>,
+                                       std_cxx11::_1,
+                                       std_cxx11::cref(boundary_functions),
+                                       std_cxx11::cref(dof_to_boundary_mapping),
+                                       std_cxx11::ref(matrix),
+                                       std_cxx11::ref(rhs_vector))),
                     scratch,
                     copy_data);
   }
@@ -1690,9 +1690,9 @@ namespace MatrixCreator
     WorkStream::run (dof.begin_active(),
                      static_cast<typename DoFHandler<dim,spacedim>::active_cell_iterator>(dof.end()),
                      &MatrixCreator::internal::laplace_assembler<dim, spacedim, typename DoFHandler<dim,spacedim>::active_cell_iterator>,
-                     std_cxx1x::bind (&MatrixCreator::internal::
+                     std_cxx11::bind (&MatrixCreator::internal::
                                       copy_local_to_global<SparseMatrix<double>, Vector<double> >,
-                                      std_cxx1x::_1,
+                                      std_cxx11::_1,
                                       &matrix,
                                       (Vector<double> *)NULL),
                      assembler_data,
@@ -1747,9 +1747,9 @@ namespace MatrixCreator
     WorkStream::run (dof.begin_active(),
                      static_cast<typename DoFHandler<dim,spacedim>::active_cell_iterator>(dof.end()),
                      &MatrixCreator::internal::laplace_assembler<dim, spacedim, typename DoFHandler<dim,spacedim>::active_cell_iterator>,
-                     std_cxx1x::bind (&MatrixCreator::internal::
+                     std_cxx11::bind (&MatrixCreator::internal::
                                       copy_local_to_global<SparseMatrix<double>, Vector<double> >,
-                                      std_cxx1x::_1,
+                                      std_cxx11::_1,
                                       &matrix,
                                       &rhs_vector),
                      assembler_data,
@@ -1802,9 +1802,9 @@ namespace MatrixCreator
     WorkStream::run (dof.begin_active(),
                      static_cast<typename hp::DoFHandler<dim,spacedim>::active_cell_iterator>(dof.end()),
                      &MatrixCreator::internal::laplace_assembler<dim, spacedim, typename hp::DoFHandler<dim,spacedim>::active_cell_iterator>,
-                     std_cxx1x::bind (&MatrixCreator::internal::
+                     std_cxx11::bind (&MatrixCreator::internal::
                                       copy_local_to_global<SparseMatrix<double>, Vector<double> >,
-                                      std_cxx1x::_1,
+                                      std_cxx11::_1,
                                       &matrix,
                                       (Vector<double> *)0),
                      assembler_data,
@@ -1856,9 +1856,9 @@ namespace MatrixCreator
     WorkStream::run (dof.begin_active(),
                      static_cast<typename hp::DoFHandler<dim,spacedim>::active_cell_iterator>(dof.end()),
                      &MatrixCreator::internal::laplace_assembler<dim, spacedim, typename hp::DoFHandler<dim,spacedim>::active_cell_iterator>,
-                     std_cxx1x::bind (&MatrixCreator::internal::
+                     std_cxx11::bind (&MatrixCreator::internal::
                                       copy_local_to_global<SparseMatrix<double>, Vector<double> >,
-                                      std_cxx1x::_1,
+                                      std_cxx11::_1,
                                       &matrix,
                                       &rhs_vector),
                      assembler_data,
index ee0d8c9cd23c9a1bd1bef50eb9690f42b0bccca3..68cdab41c883e58093670aa232237a9a98b58252 100644 (file)
@@ -94,8 +94,8 @@ PointValueHistory<dim>::PointValueHistory (const DoFHandler<dim> &dof_handler,
     = std::vector<std::vector <double> > (n_indep, std::vector <double> (0));
   indep_names = std::vector <std::string> ();
 
-  tria_listener = dof_handler.get_tria().signals.any_change.connect (std_cxx1x::bind (&PointValueHistory<dim>::tria_change_listener,
-                  std_cxx1x::ref(*this)));
+  tria_listener = dof_handler.get_tria().signals.any_change.connect (std_cxx11::bind (&PointValueHistory<dim>::tria_change_listener,
+                  std_cxx11::ref(*this)));
 }
 
 
@@ -124,8 +124,8 @@ PointValueHistory<dim>::PointValueHistory (const PointValueHistory &point_value_
   // Presume subscribe new instance?
   if (have_dof_handler)
     {
-      tria_listener = dof_handler->get_tria().signals.any_change.connect (std_cxx1x::bind     (&PointValueHistory<dim>::tria_change_listener,
-                      std_cxx1x::ref(*this)));
+      tria_listener = dof_handler->get_tria().signals.any_change.connect (std_cxx11::bind     (&PointValueHistory<dim>::tria_change_listener,
+                      std_cxx11::ref(*this)));
     }
 }
 
@@ -156,8 +156,8 @@ PointValueHistory<dim>::operator= (const PointValueHistory &point_value_history)
   // Presume subscribe new instance?
   if (have_dof_handler)
     {
-      tria_listener = dof_handler->get_tria().signals.any_change.connect (std_cxx1x::bind     (&PointValueHistory<dim>::tria_change_listener,
-                      std_cxx1x::ref(*this)));
+      tria_listener = dof_handler->get_tria().signals.any_change.connect (std_cxx11::bind     (&PointValueHistory<dim>::tria_change_listener,
+                      std_cxx11::ref(*this)));
     }
 
   return * this;
index 97db6b277bac25f31d62a1e23a7fb934289f72ec..314f8d8a7c8406567570302371ec92c75505b782 100644 (file)
@@ -217,7 +217,7 @@ void TimeDependent::end_sweep ()
   void (TimeDependent::*p) (const unsigned int, const unsigned int)
     = &TimeDependent::end_sweep;
   parallel::apply_to_subranges (0U, timesteps.size(),
-                                std_cxx1x::bind (p, this, std_cxx1x::_1, std_cxx1x::_2),
+                                std_cxx11::bind (p, this, std_cxx11::_1, std_cxx11::_2),
                                 1);
 }
 

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.