From b0c80713b662e923f96e91e429a84815feeedc75 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Sun, 24 Aug 2014 11:46:25 -0500 Subject: [PATCH] Replace all occurrences of std_cxx1x by std_cxx11. Keep the old files and namespace for backward compatibility. --- doc/doxygen/headers/c++11.h | 8 +- doc/doxygen/headers/multithreading.h | 62 +- .../headers/{std_cxx1x.h => std_cxx11.h} | 2 +- doc/news/changes.h | 8 + examples/step-13/step-13.cc | 32 +- examples/step-14/step-14.cc | 42 +- examples/step-22/step-22.cc | 4 +- examples/step-31/step-31.cc | 10 +- examples/step-32/step-32.cc | 62 +- examples/step-34/step-34.cc | 4 +- examples/step-35/step-35.cc | 10 +- examples/step-42/step-42.cc | 2 +- examples/step-43/step-43.cc | 10 +- examples/step-51/step-51.cc | 8 +- examples/step-52/step-52.cc | 10 +- examples/step-53/step-53.cc | 34 +- examples/step-9/step-9.cc | 32 +- include/deal.II/base/aligned_vector.h | 16 +- include/deal.II/base/data_out_base.h | 38 +- include/deal.II/base/function.h | 14 +- include/deal.II/base/function_lib.h | 16 +- include/deal.II/base/graph_coloring.h | 8 +- include/deal.II/base/logstream.h | 4 +- include/deal.II/base/memory_consumption.h | 8 +- include/deal.II/base/mg_level_object.h | 12 +- include/deal.II/base/parallel.h | 62 +- include/deal.II/base/parameter_handler.h | 6 +- include/deal.II/base/polynomial.h | 8 +- include/deal.II/base/std_cxx11/array.h | 45 ++ include/deal.II/base/std_cxx11/bind.h | 70 ++ .../base/std_cxx11/condition_variable.h | 49 ++ include/deal.II/base/std_cxx11/function.h | 45 ++ include/deal.II/base/std_cxx11/mutex.h | 45 ++ include/deal.II/base/std_cxx11/shared_ptr.h | 48 ++ include/deal.II/base/std_cxx11/thread.h | 45 ++ include/deal.II/base/std_cxx11/tuple.h | 66 ++ include/deal.II/base/std_cxx11/type_traits.h | 67 ++ include/deal.II/base/std_cxx1x/array.h | 34 +- include/deal.II/base/std_cxx1x/bind.h | 59 +- .../base/std_cxx1x/condition_variable.h | 38 +- include/deal.II/base/std_cxx1x/function.h | 34 +- include/deal.II/base/std_cxx1x/mutex.h | 34 +- include/deal.II/base/std_cxx1x/shared_ptr.h | 37 +- include/deal.II/base/std_cxx1x/thread.h | 34 +- include/deal.II/base/std_cxx1x/tuple.h | 55 +- include/deal.II/base/std_cxx1x/type_traits.h | 55 +- include/deal.II/base/synchronous_iterator.h | 66 +- include/deal.II/base/thread_management.h | 748 +++++++++--------- include/deal.II/base/time_stepping.h | 44 +- .../deal.II/base/time_stepping.templates.h | 43 +- include/deal.II/base/work_stream.h | 66 +- include/deal.II/distributed/tria.h | 26 +- include/deal.II/dofs/dof_handler.h | 4 +- include/deal.II/fe/fe_system.h | 2 +- include/deal.II/grid/tria.h | 6 +- include/deal.II/grid/tria_boundary.h | 2 +- include/deal.II/hp/fe_collection.h | 4 +- include/deal.II/hp/fe_values.h | 4 +- include/deal.II/hp/mapping_collection.h | 4 +- include/deal.II/hp/q_collection.h | 8 +- .../lac/chunk_sparse_matrix.templates.h | 14 +- include/deal.II/lac/filtered_matrix.h | 2 +- include/deal.II/lac/iterative_inverse.h | 8 +- include/deal.II/lac/lapack_full_matrix.h | 6 +- include/deal.II/lac/matrix_block.h | 16 +- include/deal.II/lac/parallel_vector.h | 8 +- .../deal.II/lac/parallel_vector.templates.h | 6 +- include/deal.II/lac/petsc_matrix_base.h | 6 +- include/deal.II/lac/petsc_solver.h | 6 +- include/deal.II/lac/slepc_solver.h | 4 +- .../lac/slepc_spectral_transformation.h | 4 +- include/deal.II/lac/sparse_matrix.templates.h | 46 +- include/deal.II/lac/trilinos_precondition.h | 8 +- include/deal.II/lac/trilinos_solver.h | 8 +- include/deal.II/lac/trilinos_sparse_matrix.h | 14 +- .../deal.II/lac/trilinos_sparsity_pattern.h | 10 +- include/deal.II/lac/trilinos_vector.h | 2 +- include/deal.II/lac/trilinos_vector_base.h | 6 +- include/deal.II/lac/vector.templates.h | 16 +- include/deal.II/matrix_free/dof_info.h | 6 +- .../deal.II/matrix_free/dof_info.templates.h | 6 +- include/deal.II/matrix_free/fe_evaluation.h | 2 +- .../matrix_free/mapping_info.templates.h | 2 +- include/deal.II/matrix_free/matrix_free.h | 54 +- include/deal.II/meshworker/dof_info.h | 2 +- include/deal.II/meshworker/integration_info.h | 52 +- .../meshworker/integration_info.templates.h | 2 +- include/deal.II/meshworker/local_integrator.h | 2 +- include/deal.II/meshworker/local_results.h | 2 +- include/deal.II/meshworker/loop.h | 70 +- include/deal.II/multigrid/mg_matrix.h | 6 +- include/deal.II/multigrid/mg_transfer.h | 6 +- include/deal.II/multigrid/mg_transfer_block.h | 6 +- .../deal.II/multigrid/mg_transfer_component.h | 6 +- .../multigrid/sparse_matrix_collection.h | 2 +- include/deal.II/numerics/data_out.h | 4 +- include/deal.II/numerics/data_out_dof_data.h | 32 +- include/deal.II/numerics/data_out_faces.h | 2 +- include/deal.II/numerics/data_out_rotation.h | 2 +- .../numerics/derivative_approximation.h | 2 +- .../deal.II/numerics/vector_tools.templates.h | 14 +- source/base/data_out_base.cc | 220 +++--- source/base/data_out_base.inst.in | 24 +- source/base/function.cc | 4 +- source/base/function_lib.cc | 6 +- source/base/parameter_handler.cc | 10 +- source/base/polynomial.cc | 38 +- source/distributed/solution_transfer.cc | 20 +- source/distributed/tria.cc | 10 +- source/dofs/dof_tools_constraints.cc | 58 +- source/fe/fe_system.cc | 2 +- source/fe/fe_tools.cc | 22 +- source/fe/fe_tools_interpolate.cc | 10 +- source/fe/fe_values.cc | 8 +- source/grid/grid_out.cc | 4 +- source/grid/grid_reordering.cc | 8 +- source/grid/grid_tools.cc | 10 +- source/grid/tria.cc | 36 +- source/grid/tria_boundary.cc | 2 +- source/hp/dof_handler.cc | 28 +- source/hp/fe_collection.cc | 2 +- source/hp/fe_values.cc | 2 +- source/hp/mapping_collection.cc | 4 +- source/lac/trilinos_sparse_matrix.cc | 4 +- source/lac/trilinos_vector.cc | 2 +- source/multigrid/mg_transfer_block.cc | 4 +- source/multigrid/mg_transfer_component.cc | 4 +- source/multigrid/mg_transfer_prebuilt.cc | 4 +- source/numerics/data_out.cc | 10 +- source/numerics/data_out_dof_data.cc | 28 +- source/numerics/data_out_dof_data.inst.in | 2 +- source/numerics/data_out_faces.cc | 10 +- source/numerics/data_out_rotation.cc | 10 +- source/numerics/derivative_approximation.cc | 26 +- source/numerics/error_estimator.cc | 10 +- source/numerics/error_estimator_1d.cc | 2 +- source/numerics/matrix_tools.cc | 84 +- source/numerics/point_value_history.cc | 12 +- source/numerics/time_dependent.cc | 2 +- 139 files changed, 1916 insertions(+), 1717 deletions(-) rename doc/doxygen/headers/{std_cxx1x.h => std_cxx11.h} (98%) create mode 100644 include/deal.II/base/std_cxx11/array.h create mode 100644 include/deal.II/base/std_cxx11/bind.h create mode 100644 include/deal.II/base/std_cxx11/condition_variable.h create mode 100644 include/deal.II/base/std_cxx11/function.h create mode 100644 include/deal.II/base/std_cxx11/mutex.h create mode 100644 include/deal.II/base/std_cxx11/shared_ptr.h create mode 100644 include/deal.II/base/std_cxx11/thread.h create mode 100644 include/deal.II/base/std_cxx11/tuple.h create mode 100644 include/deal.II/base/std_cxx11/type_traits.h diff --git a/doc/doxygen/headers/c++11.h b/doc/doxygen/headers/c++11.h index c543616d6f..bafba4d1af 100644 --- a/doc/doxygen/headers/c++11.h +++ b/doc/doxygen/headers/c++11.h @@ -39,11 +39,11 @@ * 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 @@ -51,10 +51,10 @@ * BOOST library 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. * diff --git a/doc/doxygen/headers/multithreading.h b/doc/doxygen/headers/multithreading.h index fd127a27b4..79317d676b 100644 --- a/doc/doxygen/headers/multithreading.h +++ b/doc/doxygen/headers/multithreading.h @@ -492,21 +492,21 @@ 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 std_cxx1x::bind + * href="http://www.boost.org/doc/libs/1_37_0/libs/bind/bind.html">std_cxx11::bind * to bind certain arguments to the vmult_one_row * 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 src and writing the result into a * temporary copy of dst, neither of which is what we desired). * Finally, notice the grainsize of a minimum of 200 rows of a matrix that @@ -548,11 +548,11 @@ 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 @@ -623,10 +623,10 @@ 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 @@ -1034,25 +1034,25 @@ // ...is the same as: WorkStream::run (dof_handler.begin_active(), dof_handler.end(), - std_cxx1x::bind(&MyClass::assemble_on_one_cell, + std_cxx11::bind(&MyClass::assemble_on_one_cell, *this, - std_cxx1x::_1, - std_cxx1x::_2, - std_cxx1x::_3), - std_cxx1x::bind(&MyClass::copy_local_to_global, + std_cxx11::_1, + std_cxx11::_2, + std_cxx11::_3), + std_cxx11::bind(&MyClass::copy_local_to_global, *this, - std_cxx1x::_1), + std_cxx11::_1), per_task_data); * @endcode - * Note how std_cxx1x::bind produces a function object that takes three + * Note how std_cxx11::bind produces a function object that takes three * arguments by binding the member function to the *this - * object. std_cxx1x::_1, std_cxx1x::_2 and std_cxx1x::_3 are placeholders for the first, + * object. std_cxx11::_1, std_cxx11::_2 and std_cxx11::_3 are placeholders for the first, * second and third argument that can be specified later on. In other words, for * example if p is the result of the first call to - * std_cxx1x::bind, then the call p(cell, scratch_data, + * std_cxx11::bind, then the call p(cell, scratch_data, * per_task_data) will result in executing * this-@>assemble_on_one_cell (cell, scratch_data, per_task_data), - * i.e. std_cxx1x::bind has bound the object to the function pointer + * i.e. std_cxx11::bind has bound the object to the function pointer * but left the three arguments open for later. * * Similarly, let us assume that MyClass::assemble_on_one_cell @@ -1074,24 +1074,24 @@ * @code WorkStream::run (dof_handler.begin_active(), dof_handler.end(), - std_cxx1x::bind(&MyClass::assemble_on_one_cell, + std_cxx11::bind(&MyClass::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::copy_local_to_global, + std_cxx11::bind(&MyClass::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 std_cxx1x::_1, std_cxx1x::_2 - * and std_cxx1x::_3. + * in at the positions indicated by std_cxx11::_1, std_cxx11::_2 + * and std_cxx11::_3. * * There are refinements to the WorkStream::run function shown above. * For example, one may realize that the basic idea above can only scale diff --git a/doc/doxygen/headers/std_cxx1x.h b/doc/doxygen/headers/std_cxx11.h similarity index 98% rename from doc/doxygen/headers/std_cxx1x.h rename to doc/doxygen/headers/std_cxx11.h index 02f038e2ea..6fc7767542 100644 --- a/doc/doxygen/headers/std_cxx1x.h +++ b/doc/doxygen/headers/std_cxx11.h @@ -28,6 +28,6 @@ * * @ingroup CPP11 */ -namespace std_cxx1x +namespace std_cxx11 { } diff --git a/doc/news/changes.h b/doc/news/changes.h index 51faa4b861..d79e0ce34c 100644 --- a/doc/news/changes.h +++ b/doc/news/changes.h @@ -97,6 +97,14 @@ inconvenience this causes.
    +
  1. 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. +
    + (Wolfgang Bangerth, 2014/09/01) +
  2. +
  3. New: Most of the operations done on Vector (like add, sadd, etc.) are now vectorized (SIMD) using OpenMP 4.0
    diff --git a/examples/step-13/step-13.cc b/examples/step-13/step-13.cc index b89d5fcc82..2bc8567713 100644 --- a/examples/step-13/step-13.cc +++ b/examples/step-13/step-13.cc @@ -777,20 +777,20 @@ namespace Step13 WorkStream::run(dof_handler.begin_active(), dof_handler.end(), - std_cxx1x::bind(&Solver::local_assemble_matrix, + std_cxx11::bind(&Solver::local_assemble_matrix, this, - std_cxx1x::_1, - std_cxx1x::_2, - std_cxx1x::_3), - std_cxx1x::bind(&Solver::copy_local_to_global, + std_cxx11::_1, + std_cxx11::_2, + std_cxx11::_3), + std_cxx11::bind(&Solver::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 std_cxx1x::bind requires + // The syntax above using std_cxx11::bind 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 // std::bind (or, if the compiler is too old, a // replacement for it, which we generically call - // std_cxx1x::bind) which takes a pointer to a + // std_cxx11::bind) which takes a pointer to a // (member) function and then binds 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 - // std_cxx1x::_1, std_cxx1x::_2, etc., + // std_cxx11::_1, std_cxx11::_2, etc., // mean. (These arguments are called placeholders.) The - // idea of using std_cxx1x::bind in the first of + // idea of using std_cxx11::bind 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 void f(double x, double y). Then, // creating a variable p of type - // std_cxx1x::function@ and - // initializing p=std_cxx1x::bind(&f, std_cxx1x::_2, - // std_cxx1x::_1) then calling p(1,2) will + // std_cxx11::function@ and + // initializing p=std_cxx11::bind(&f, std_cxx11::_2, + // std_cxx11::_1) then calling p(1,2) will // result in calling f(2,1). // // @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(), diff --git a/examples/step-14/step-14.cc b/examples/step-14/step-14.cc index bcb7d493ed..317168cc72 100644 --- a/examples/step-14/step-14.cc +++ b/examples/step-14/step-14.cc @@ -573,15 +573,15 @@ namespace Step14 WorkStream::run(dof_handler.begin_active(), dof_handler.end(), - std_cxx1x::bind(&Solver::local_assemble_matrix, + std_cxx11::bind(&Solver::local_assemble_matrix, this, - std_cxx1x::_1, - std_cxx1x::_2, - std_cxx1x::_3), - std_cxx1x::bind(&Solver::copy_local_to_global, + std_cxx11::_1, + std_cxx11::_2, + std_cxx11::_3), + std_cxx11::bind(&Solver::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 &error_indicators) const; - void estimate_on_one_cell (const SynchronousIterators::iterator> > &cell_and_error, WeightedResidualScratchData &scratch_data, WeightedResidualCopyData ©_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::iterator> > &cell_and_error, const Vector &primal_solution, const Vector &dual_weights, @@ -2504,7 +2504,7 @@ namespace Step14 .get_tria().n_active_cells()); typedef - std_cxx1x::tuple::iterator> + std_cxx11::tuple::iterator> IteratorTuple; SynchronousIterators @@ -2516,13 +2516,13 @@ namespace Step14 WorkStream::run(cell_and_error_begin, cell_and_error_end, - std_cxx1x::bind(&WeightedResidual::estimate_on_one_cell, + std_cxx11::bind(&WeightedResidual::estimate_on_one_cell, this, - std_cxx1x::_1, - std_cxx1x::_2, - std_cxx1x::_3, - std_cxx1x::ref(face_integrals)), - std_cxx1x::function(), + std_cxx11::_1, + std_cxx11::_2, + std_cxx11::_3, + std_cxx11::ref(face_integrals)), + std_cxx11::function(), WeightedResidualScratchData (primal_solver, dual_solver, primal_solution, @@ -2563,7 +2563,7 @@ namespace Step14 template void WeightedResidual:: - estimate_on_one_cell (const SynchronousIterators::iterator> > &cell_and_error, WeightedResidualScratchData &scratch_data, WeightedResidualCopyData ©_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 // error_indicators 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 void WeightedResidual:: - integrate_over_cell (const SynchronousIterators::iterator> > &cell_and_error, const Vector &primal_solution, const Vector &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; } diff --git a/examples/step-22/step-22.cc b/examples/step-22/step-22.cc index 0088538e07..868fd467a4 100644 --- a/examples/step-22/step-22.cc +++ b/examples/step-22/step-22.cc @@ -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::type> A_preconditioner; + std_cxx11::shared_ptr::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::type>(new typename InnerPreconditioner::type()); + = std_cxx11::shared_ptr::type>(new typename InnerPreconditioner::type()); A_preconditioner->initialize (system_matrix.block(0,0), typename InnerPreconditioner::type::AdditionalData()); diff --git a/examples/step-31/step-31.cc b/examples/step-31/step-31.cc index c40b9bd5a6..8e7580801f 100644 --- a/examples/step-31/step-31.cc +++ b/examples/step-31/step-31.cc @@ -530,8 +530,8 @@ namespace Step31 double old_time_step; unsigned int timestep_number; - std_cxx1x::shared_ptr Amg_preconditioner; - std_cxx1x::shared_ptr Mp_preconditioner; + std_cxx11::shared_ptr Amg_preconditioner; + std_cxx11::shared_ptr 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 + Amg_preconditioner = std_cxx11::shared_ptr (new TrilinosWrappers::PreconditionAMG()); std::vector > 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 std_cxx1x::shared_ptr + // wrap the preconditioners into a std_cxx11::shared_ptr // 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 + Mp_preconditioner = std_cxx11::shared_ptr (new TrilinosWrappers::PreconditionIC()); Mp_preconditioner->initialize(stokes_preconditioner_matrix.block(1,1)); diff --git a/examples/step-32/step-32.cc b/examples/step-32/step-32.cc index da200f7edf..0ae17269c6 100644 --- a/examples/step-32/step-32.cc +++ b/examples/step-32/step-32.cc @@ -915,9 +915,9 @@ namespace Step32 double old_time_step; unsigned int timestep_number; - std_cxx1x::shared_ptr Amg_preconditioner; - std_cxx1x::shared_ptr Mp_preconditioner; - std_cxx1x::shared_ptr T_preconditioner; + std_cxx11::shared_ptr Amg_preconditioner; + std_cxx11::shared_ptr Mp_preconditioner; + std_cxx11::shared_ptr 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 std_cxx1x::bind to + // Note how we use the construct std_cxx11::bind to // create a function object that satisfies this requirement. It uses - // placeholders std_cxx1x::_1, std_cxx1x::_2, - // std_cxx1x::_3 for the local assembly function that specify + // placeholders std_cxx11::_1, std_cxx11::_2, + // std_cxx11::_3 for the local assembly function that specify // cell, scratch data, and copy data, as well as the placeholder - // std_cxx1x::_1 for the copy function that expects the + // std_cxx11::_1 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 // assemble_linear_system() 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:: + std_cxx11::bind (&BoussinesqFlowProblem:: local_assemble_stokes_preconditioner, this, - std_cxx1x::_1, - std_cxx1x::_2, - std_cxx1x::_3), - std_cxx1x::bind (&BoussinesqFlowProblem:: + std_cxx11::_1, + std_cxx11::_2, + std_cxx11::_3), + std_cxx11::bind (&BoussinesqFlowProblem:: copy_local_to_global_stokes_preconditioner, this, - std_cxx1x::_1), + std_cxx11::_1), Assembly::Scratch:: StokesPreconditioner (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:: + std_cxx11::bind (&BoussinesqFlowProblem:: local_assemble_stokes_system, this, - std_cxx1x::_1, - std_cxx1x::_2, - std_cxx1x::_3), - std_cxx1x::bind (&BoussinesqFlowProblem:: + std_cxx11::_1, + std_cxx11::_2, + std_cxx11::_3), + std_cxx11::bind (&BoussinesqFlowProblem:: copy_local_to_global_stokes_system, this, - std_cxx1x::_1), + std_cxx11::_1), Assembly::Scratch:: StokesSystem (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:: + std_cxx11::bind (&BoussinesqFlowProblem:: local_assemble_temperature_matrix, this, - std_cxx1x::_1, - std_cxx1x::_2, - std_cxx1x::_3), - std_cxx1x::bind (&BoussinesqFlowProblem:: + std_cxx11::_1, + std_cxx11::_2, + std_cxx11::_3), + std_cxx11::bind (&BoussinesqFlowProblem:: copy_local_to_global_temperature_matrix, this, - std_cxx1x::_1), + std_cxx11::_1), Assembly::Scratch:: TemperatureMatrix (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:: + std_cxx11::bind (&BoussinesqFlowProblem:: 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:: + std_cxx11::_1, + std_cxx11::_2, + std_cxx11::_3), + std_cxx11::bind (&BoussinesqFlowProblem:: copy_local_to_global_temperature_rhs, this, - std_cxx1x::_1), + std_cxx11::_1), Assembly::Scratch:: TemperatureRHS (temperature_fe, stokes_fe, mapping, quadrature_formula), diff --git a/examples/step-34/step-34.cc b/examples/step-34/step-34.cc index f675772db7..a625afe550 100644 --- a/examples/step-34/step-34.cc +++ b/examples/step-34/step-34.cc @@ -288,7 +288,7 @@ namespace Step34 Functions::ParsedFunction exact_solution; unsigned int singular_quadrature_order; - std_cxx1x::shared_ptr > quadrature; + std_cxx11::shared_ptr > quadrature; SolverControl solver_control; @@ -427,7 +427,7 @@ namespace Step34 prm.enter_subsection("Quadrature rules"); { quadrature = - std_cxx1x::shared_ptr > + std_cxx11::shared_ptr > (new QuadratureSelector (prm.get("Quadrature type"), prm.get_integer("Quadrature order"))); singular_quadrature_order = prm.get_integer("Singular quadrature order"); diff --git a/examples/step-35/step-35.cc b/examples/step-35/step-35.cc index cd9d97906e..a7d9093f59 100644 --- a/examples/step-35/step-35.cc +++ b/examples/step-35/step-35.cc @@ -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::active_cell_iterator, + typedef std_cxx11::tuple< typename DoFHandler::active_cell_iterator, typename DoFHandler::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 > obstacle; + const std_cxx11::shared_ptr > obstacle; struct RefinementStrategy { diff --git a/examples/step-43/step-43.cc b/examples/step-43/step-43.cc index 5647ece9ec..732dd89921 100644 --- a/examples/step-43/step-43.cc +++ b/examples/step-43/step-43.cc @@ -33,7 +33,7 @@ #include #include #include -#include +#include #include #include @@ -590,8 +590,8 @@ namespace Step43 const double porosity; const double AOS_threshold; - std_cxx1x::shared_ptr Amg_preconditioner; - std_cxx1x::shared_ptr Mp_preconditioner; + std_cxx11::shared_ptr Amg_preconditioner; + std_cxx11::shared_ptr Mp_preconditioner; bool rebuild_saturation_matrix; @@ -985,11 +985,11 @@ namespace Step43 { assemble_darcy_preconditioner (); - Amg_preconditioner = std_cxx1x::shared_ptr + Amg_preconditioner = std_cxx11::shared_ptr (new TrilinosWrappers::PreconditionIC()); Amg_preconditioner->initialize(darcy_preconditioner_matrix.block(0,0)); - Mp_preconditioner = std_cxx1x::shared_ptr + Mp_preconditioner = std_cxx11::shared_ptr (new TrilinosWrappers::PreconditionIC()); Mp_preconditioner->initialize(darcy_preconditioner_matrix.block(1,1)); diff --git a/examples/step-51/step-51.cc b/examples/step-51/step-51.cc index da6e062820..fff4ff53ac 100644 --- a/examples/step-51/step-51.cc +++ b/examples/step-51/step-51.cc @@ -1032,10 +1032,10 @@ namespace Step51 WorkStream::run(dof_handler_u_post.begin_active(), dof_handler_u_post.end(), - std_cxx1x::bind (&HDG::postprocess_one_cell, - std_cxx1x::ref(*this), - std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3), - std_cxx1x::function(), + std_cxx11::bind (&HDG::postprocess_one_cell, + std_cxx11::ref(*this), + std_cxx11::_1, std_cxx11::_2, std_cxx11::_3), + std_cxx11::function(), scratch, 0U); } diff --git a/examples/step-52/step-52.cc b/examples/step-52/step-52.cc index 749901a711..d7308c9cd8 100644 --- a/examples/step-52/step-52.cc +++ b/examples/step-52/step-52.cc @@ -440,7 +440,7 @@ namespace Step52 for (unsigned int i=0; i #include -#include +#include #include @@ -46,11 +46,11 @@ public: get_new_point_on_quad (const typename Triangulation::quad_iterator &quad) const; private: - std_cxx1x::array pull_back (const Point &p) const; - Point push_forward (const std_cxx1x::array &preimage) const; + std_cxx11::array pull_back (const Point &p) const; + Point push_forward (const std_cxx11::array &preimage) const; template - static std_cxx1x::array average (const std_cxx1x::array (&array)[N]); + static std_cxx11::array average (const std_cxx11::array (&array)[N]); const Point center; }; @@ -64,7 +64,7 @@ SphereGeometry::SphereGeometry (const Point ¢er) template <> -std_cxx1x::array +std_cxx11::array 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 result; + std_cxx11::array 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 &preimage) const +SphereGeometry<2>::push_forward (const std_cxx11::array &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 &preimage) con template <> -std_cxx1x::array +std_cxx11::array 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 result; + std_cxx11::array 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 &preimage) const +SphereGeometry<3>::push_forward (const std_cxx11::array &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 &preimage) con template <> template -std_cxx1x::array -SphereGeometry<2>::average (const std_cxx1x::array (&array)[N]) +std_cxx11::array +SphereGeometry<2>::average (const std_cxx11::array (&array)[N]) { - std_cxx1x::array result; + std_cxx11::array result; // average the radii first. this is uncritical { @@ -179,10 +179,10 @@ SphereGeometry<2>::average (const std_cxx1x::array (&array)[N]) template <> template -std_cxx1x::array -SphereGeometry<3>::average (const std_cxx1x::array (&array)[N]) +std_cxx11::array +SphereGeometry<3>::average (const std_cxx11::array (&array)[N]) { - std_cxx1x::array result; + std_cxx11::array result; // average the radii first. this is uncritical { @@ -250,7 +250,7 @@ Point SphereGeometry:: get_new_point_on_quad (const typename Triangulation::quad_iterator &quad) const { - std_cxx1x::array preimages[4] = { pull_back (quad->vertex(0)), + std_cxx11::array preimages[4] = { pull_back (quad->vertex(0)), pull_back (quad->vertex(1)), pull_back (quad->vertex(2)), pull_back (quad->vertex(3)) diff --git a/examples/step-9/step-9.cc b/examples/step-9/step-9.cc index eae21871bf..21aae8a598 100644 --- a/examples/step-9/step-9.cc +++ b/examples/step-9/step-9.cc @@ -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 static - void estimate_cell (const SynchronousIterators::active_cell_iterator, + void estimate_cell (const SynchronousIterators::active_cell_iterator, Vector::iterator> > &cell, EstimateScratchData &scratch_data, const EstimateCopyData ©_data); @@ -1027,7 +1027,7 @@ namespace Step9 ExcInvalidVectorLength (error_per_cell.size(), dof_handler.get_tria().n_active_cells())); - typedef std_cxx1x::tuple::active_cell_iterator,Vector::iterator> + typedef std_cxx11::tuple::active_cell_iterator,Vector::iterator> IteratorTuple; SynchronousIterators @@ -1039,7 +1039,7 @@ namespace Step9 WorkStream::run (begin_sync_it, end_sync_it, &GradientEstimation::template estimate_cell, - std_cxx1x::function (), + std_cxx11::function (), EstimateScratchData (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 &, + // std_cxx11::function &, // EstimateScratchData &, // EstimateCopyData &)> - // (std_cxx1x::bind (&GradientEstimation::template estimate_cell, - // std_cxx1x::_1, - // std_cxx1x::_2)) + // (std_cxx11::bind (&GradientEstimation::template estimate_cell, + // 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 void - GradientEstimation::estimate_cell (const SynchronousIterators::active_cell_iterator, + GradientEstimation::estimate_cell (const SynchronousIterators::active_cell_iterator, Vector::iterator> > &cell, EstimateScratchData &scratch_data, const EstimateCopyData &) @@ -1112,7 +1112,7 @@ namespace Step9 active_neighbors.reserve (GeometryInfo::faces_per_cell * GeometryInfo::max_children_per_face); - typename DoFHandler::active_cell_iterator cell_it(std_cxx1x::get<0>(cell.iterators)); + typename DoFHandler::active_cell_iterator cell_it(std_cxx11::get<0>(cell.iterators)); // First initialize the FEValues object, as well as the // Y tensor: @@ -1147,14 +1147,14 @@ namespace Step9 // neighbors, of course. active_neighbors.clear (); for (unsigned int face_no=0; face_no::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::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::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_non_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())); diff --git a/include/deal.II/base/aligned_vector.h b/include/deal.II/base/aligned_vector.h index 77ec5a95e1..a91f2dc38b 100644 --- a/include/deal.II/base/aligned_vector.h +++ b/include/deal.II/base/aligned_vector.h @@ -19,7 +19,7 @@ #define __deal2__aligned_vector_h #include -#include +#include #include #include #include @@ -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::value == true) + if (std_cxx11::is_trivial::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::value == true && + if (std_cxx11::is_trivial::value == true && types_are_equal::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::value == true && trivial_element) + if (std_cxx11::is_trivial::value == true && trivial_element) std::memset ((void *)(destination_+begin), 0, (end-begin)*sizeof(T)); else // initialize memory and set @@ -505,7 +505,7 @@ AlignedVector::resize (const size_type size_in, const T &init) { const size_type old_size = size(); - if (std_cxx1x::is_trivial::value == false && size_in < old_size) + if (std_cxx11::is_trivial::value == false && size_in < old_size) { // call destructor on fields that are released while (_end_data != _data+size_in) @@ -579,7 +579,7 @@ AlignedVector::clear () { if (_data != 0) { - if (std_cxx1x::is_trivial::value == false) + if (std_cxx11::is_trivial::value == false) while (_end_data != _data) (--_end_data)->~T(); @@ -604,7 +604,7 @@ AlignedVector::push_back (const T in_data) Assert (_end_data <= _end_allocated, ExcInternalError()); if (_end_data == _end_allocated) reserve (std::max(2*capacity(),static_cast(16))); - if (std_cxx1x::is_trivial::value == false) + if (std_cxx11::is_trivial::value == false) new (_end_data) T; *_end_data++ = in_data; } @@ -646,7 +646,7 @@ AlignedVector::insert_back (ForwardIterator begin, reserve (old_size + (end-begin)); for ( ; begin != end; ++begin, ++_end_data) { - if (std_cxx1x::is_trivial::value == false) + if (std_cxx11::is_trivial::value == false) new (_end_data) T; *_end_data = *begin; } diff --git a/include/deal.II/base/data_out_base.h b/include/deal.II/base/data_out_base.h index bd5721e7a8..625baa1e73 100644 --- a/include/deal.II/base/data_out_base.h +++ b/include/deal.II/base/data_out_base.h @@ -22,7 +22,7 @@ #include #include #include -#include +#include #include #include @@ -1460,7 +1460,7 @@ namespace DataOutBase template void write_dx (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const DXFlags &flags, std::ostream &out); @@ -1514,7 +1514,7 @@ namespace DataOutBase template void write_eps (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const EpsFlags &flags, std::ostream &out); @@ -1527,7 +1527,7 @@ namespace DataOutBase template void write_eps (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const EpsFlags &flags, std::ostream &out); @@ -1545,7 +1545,7 @@ namespace DataOutBase template void write_gmv (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const GmvFlags &flags, std::ostream &out); @@ -1612,7 +1612,7 @@ namespace DataOutBase template void write_gnuplot (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const GnuplotFlags &flags, std::ostream &out); @@ -1666,7 +1666,7 @@ namespace DataOutBase template void write_povray (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const PovrayFlags &flags, std::ostream &out); @@ -1680,7 +1680,7 @@ namespace DataOutBase template void write_tecplot (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const TecplotFlags &flags, std::ostream &out); @@ -1709,7 +1709,7 @@ namespace DataOutBase void write_tecplot_binary ( const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const TecplotFlags &flags, std::ostream &out); @@ -1731,7 +1731,7 @@ namespace DataOutBase template void write_ucd (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const UcdFlags &flags, std::ostream &out); @@ -1757,7 +1757,7 @@ namespace DataOutBase template void write_vtk (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const VtkFlags &flags, std::ostream &out); @@ -1789,7 +1789,7 @@ namespace DataOutBase template void write_vtu (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const VtkFlags &flags, std::ostream &out); @@ -1819,7 +1819,7 @@ namespace DataOutBase template void write_vtu_main (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const VtkFlags &flags, std::ostream &out); @@ -1847,7 +1847,7 @@ namespace DataOutBase template void write_svg (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const SvgFlags &flags, std::ostream &out); @@ -1895,7 +1895,7 @@ namespace DataOutBase void write_deal_II_intermediate ( const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const Deal_II_IntermediateFlags &flags, std::ostream &out); @@ -1933,7 +1933,7 @@ namespace DataOutBase template void write_filtered_data (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, DataOutFilter &filtered_data); /** @@ -2709,7 +2709,7 @@ protected: * collection of scalar fields. */ virtual - std::vector > + std::vector > get_vector_data_ranges () const; /** @@ -2947,7 +2947,7 @@ protected: * collection of scalar fields. */ virtual - std::vector > + std::vector > 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::vector > vector_data_ranges; }; diff --git a/include/deal.II/base/function.h b/include/deal.II/base/function.h index e3c653fc4b..77294fdabd 100644 --- a/include/deal.II/base/function.h +++ b/include/deal.II/base/function.h @@ -24,7 +24,7 @@ #include #include #include -#include +#include #include @@ -577,9 +577,9 @@ protected: * or we could write it like so: * @code * ScalarFunctionFromFunctionObject - * my_distance_object (std_cxx1x::bind (&Point::distance, + * my_distance_object (std_cxx11::bind (&Point::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 interface. */ - ScalarFunctionFromFunctionObject (const std_cxx1x::function &)> &function_object); + ScalarFunctionFromFunctionObject (const std_cxx11::function &)> &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 &)> function_object; + const std_cxx11::function &)> 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 &)> &function_object, + VectorFunctionFromScalarFunctionObject (const std_cxx11::function &)> &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 &)> function_object; + const std_cxx11::function &)> function_object; /** * The vector component whose value is to be filled by the given scalar diff --git a/include/deal.II/base/function_lib.h b/include/deal.II/base/function_lib.h index e75bc47d72..a12fe26aa9 100644 --- a/include/deal.II/base/function_lib.h +++ b/include/deal.II/base/function_lib.h @@ -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 #include -#include +#include 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,dim> &coordinate_values, + InterpolatedTensorProductGridData (const std_cxx11::array,dim> &coordinate_values, const Table &data_values); /** @@ -1251,7 +1251,7 @@ namespace Functions /** * The set of coordinate values in each of the coordinate directions. */ - const std_cxx1x::array,dim> coordinate_values; + const std_cxx11::array,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,dim> &interval_endpoints, - const std_cxx1x::array &n_subintervals, + InterpolatedUniformGridData (const std_cxx11::array,dim> &interval_endpoints, + const std_cxx11::array &n_subintervals, const Table &data_values); /** @@ -1335,12 +1335,12 @@ namespace Functions /** * The set of interval endpoints in each of the coordinate directions. */ - const std_cxx1x::array,dim> interval_endpoints; + const std_cxx11::array,dim> interval_endpoints; /** * The number of subintervals in each of the coordinate directions. */ - const std_cxx1x::array n_subintervals; + const std_cxx11::array n_subintervals; /** * The data that is to be interpolated. diff --git a/include/deal.II/base/graph_coloring.h b/include/deal.II/base/graph_coloring.h index f3c58a24b3..8ec3788fd1 100644 --- a/include/deal.II/base/graph_coloring.h +++ b/include/deal.II/base/graph_coloring.h @@ -21,7 +21,7 @@ #include #include -#include +#include #include #include #include @@ -109,7 +109,7 @@ namespace GraphColoring std::vector > create_partitioning(const Iterator &begin, const typename identity::type &end, - const std_cxx1x::function (const Iterator &)> &get_conflict_indices) + const std_cxx11::function (const Iterator &)> &get_conflict_indices) { // Number of iterators. unsigned int n_iterators = 0; @@ -212,7 +212,7 @@ namespace GraphColoring template void make_dsatur_coloring(std::vector &partition, - const std_cxx1x::function (const Iterator &)> &get_conflict_indices, + const std_cxx11::function (const Iterator &)> &get_conflict_indices, std::vector > &partition_coloring) { partition_coloring.clear (); @@ -512,7 +512,7 @@ namespace GraphColoring std::vector > make_graph_coloring(const Iterator &begin, const typename identity::type &end, - const std_cxx1x::function (const typename identity::type &)> &get_conflict_indices) + const std_cxx11::function (const typename identity::type &)> &get_conflict_indices) { Assert (begin != end, ExcMessage ("GraphColoring is not prepared to deal with empty ranges!")); diff --git a/include/deal.II/base/logstream.h b/include/deal.II/base/logstream.h index 2c9519b6d2..9a7f4fff3a 100644 --- a/include/deal.II/base/logstream.h +++ b/include/deal.II/base/logstream.h @@ -20,7 +20,7 @@ #include #include #include -#include +#include #include #include @@ -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 > outstreams; + Threads::ThreadLocalStorage > outstreams; template friend LogStream &operator << (LogStream &log, const T &t); }; diff --git a/include/deal.II/base/memory_consumption.h b/include/deal.II/base/memory_consumption.h index b88f670ca2..f7723083cd 100644 --- a/include/deal.II/base/memory_consumption.h +++ b/include/deal.II/base/memory_consumption.h @@ -19,7 +19,7 @@ #include -#include +#include #include #include @@ -438,7 +438,7 @@ namespace MemoryConsumption */ template inline - std::size_t memory_consumption (const std_cxx1x::shared_ptr &); + std::size_t memory_consumption (const std_cxx11::shared_ptr &); } @@ -690,9 +690,9 @@ namespace MemoryConsumption template inline std::size_t - memory_consumption (const std_cxx1x::shared_ptr &) + memory_consumption (const std_cxx11::shared_ptr &) { - return sizeof(std_cxx1x::shared_ptr); + return sizeof(std_cxx11::shared_ptr); } diff --git a/include/deal.II/base/mg_level_object.h b/include/deal.II/base/mg_level_object.h index cbd7a30574..e43c3699ab 100644 --- a/include/deal.II/base/mg_level_object.h +++ b/include/deal.II/base/mg_level_object.h @@ -20,7 +20,7 @@ #include #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -126,7 +126,7 @@ private: /** * Array of the objects to be held. */ - std::vector > objects; + std::vector > objects; }; @@ -177,7 +177,7 @@ MGLevelObject::resize (const unsigned int new_minlevel, minlevel = new_minlevel; for (unsigned int i=0; i (new Object)); + objects.push_back(std_cxx11::shared_ptr (new Object)); } @@ -185,7 +185,7 @@ template MGLevelObject & MGLevelObject::operator = (const double d) { - typename std::vector >::iterator v; + typename std::vector >::iterator v; for (v = objects.begin(); v != objects.end(); ++v) **v=d; return *this; @@ -196,7 +196,7 @@ template void MGLevelObject::clear () { - typename std::vector >::iterator v; + typename std::vector >::iterator v; for (v = objects.begin(); v != objects.end(); ++v) (*v)->clear(); } @@ -239,7 +239,7 @@ std::size_t MGLevelObject::memory_consumption () const { std::size_t result = sizeof(*this); - typedef typename std::vector >::const_iterator Iter; + typedef typename std::vector >::const_iterator Iter; const Iter end = objects.end(); for (Iter o=objects.begin(); o!=end; ++o) result += (*o)->memory_consumption(); diff --git a/include/deal.II/base/parallel.h b/include/deal.II/base/parallel.h index 9a2e175175..b142c64d0b 100644 --- a/include/deal.II/base/parallel.h +++ b/include/deal.II/base/parallel.h @@ -23,9 +23,9 @@ #include #include -#include -#include -#include +#include +#include +#include #include @@ -86,9 +86,9 @@ namespace parallel static void apply (const F &f, - const std_cxx1x::tuple &p) + const std_cxx11::tuple &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 &p) + const std_cxx11::tuple &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 &p) + const std_cxx11::tuple &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 Iterators; + typedef std_cxx11::tuple Iterators; typedef SynchronousIterators 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 + std_cxx11::tuple Iterators; typedef SynchronousIterators SyncIterators; Iterators x_begin (begin_in1, in2, out); @@ -328,7 +328,7 @@ namespace parallel *out++ = predicate (*in1++, *in2++, *in3++); #else typedef - std_cxx1x::tuple + std_cxx11::tuple Iterators; typedef SynchronousIterators 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 - * std_cxx1x::bind function to + * std_cxx11::bind function to * convert * mat_vec_on_subranged from a * function that takes 5 arguments to one * taking 2 by binding the remaining * arguments (the modifiers - * std_cxx1x::ref and - * std_cxx1x::cref make sure + * std_cxx11::ref and + * std_cxx11::cref 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 (begin, end, grainsize), - std_cxx1x::bind (&internal::apply_to_subranges, - std_cxx1x::_1, - std_cxx1x::cref(f)), + std_cxx11::bind (&internal::apply_to_subranges, + 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 reductor; + const std_cxx11::function reductor; }; #endif } @@ -690,10 +690,10 @@ namespace parallel * std::sqrt * (parallel::accumulate_from_subranges * (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); * } * diff --git a/include/deal.II/base/parameter_handler.h b/include/deal.II/base/parameter_handler.h index d2c8394306..cb8b963983 100644 --- a/include/deal.II/base/parameter_handler.h +++ b/include/deal.II/base/parameter_handler.h @@ -21,7 +21,7 @@ #include #include #include -#include +#include #include #include @@ -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 > patterns; + std::vector > 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(Patterns::pattern_factory(descriptions[j]))); + patterns.push_back (std_cxx11::shared_ptr(Patterns::pattern_factory(descriptions[j]))); } diff --git a/include/deal.II/base/polynomial.h b/include/deal.II/base/polynomial.h index 49b75b09c2..9b00329c01 100644 --- a/include/deal.II/base/polynomial.h +++ b/include/deal.II/base/polynomial.h @@ -23,7 +23,7 @@ #include #include #include -#include +#include #include @@ -398,7 +398,7 @@ namespace Polynomials /** * Coefficients for the interval $[0,1]$. */ - static std::vector > > shifted_coefficients; + static std::vector > > 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 > > recursive_coefficients; + static std::vector > > 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 > > recursive_coefficients; + static std::vector > > 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 index 0000000000..05e94ad42f --- /dev/null +++ b/include/deal.II/base/std_cxx11/array.h @@ -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 + +#ifdef DEAL_II_WITH_CXX11 + +# include +DEAL_II_NAMESPACE_OPEN +namespace std_cxx11 +{ + using std::array; +} +DEAL_II_NAMESPACE_CLOSE + +#else + +#include +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 index 0000000000..da6cc9a2ac --- /dev/null +++ b/include/deal.II/base/std_cxx11/bind.h @@ -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 + +#ifdef DEAL_II_WITH_CXX11 + +# include + +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 + +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 index 0000000000..83a3cfb056 --- /dev/null +++ b/include/deal.II/base/std_cxx11/condition_variable.h @@ -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 + +#ifdef DEAL_II_WITH_CXX11 + +# include +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 +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 index 0000000000..765a09263e --- /dev/null +++ b/include/deal.II/base/std_cxx11/function.h @@ -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 + +#ifdef DEAL_II_WITH_CXX11 + +# include +DEAL_II_NAMESPACE_OPEN +namespace std_cxx11 +{ + using std::function; +} +DEAL_II_NAMESPACE_CLOSE + +#else + +#include +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 index 0000000000..bb8a714cdd --- /dev/null +++ b/include/deal.II/base/std_cxx11/mutex.h @@ -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 + +#ifdef DEAL_II_WITH_CXX11 + +# include +DEAL_II_NAMESPACE_OPEN +namespace std_cxx11 +{ + using std::mutex; +} +DEAL_II_NAMESPACE_CLOSE + +#else + +# include +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 index 0000000000..95ba2a24bc --- /dev/null +++ b/include/deal.II/base/std_cxx11/shared_ptr.h @@ -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 + +#ifdef DEAL_II_WITH_CXX11 + +# include +DEAL_II_NAMESPACE_OPEN +namespace std_cxx11 +{ + using std::shared_ptr; + using std::enable_shared_from_this; +} +DEAL_II_NAMESPACE_CLOSE + +#else + +#include +#include +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 index 0000000000..19276fbdae --- /dev/null +++ b/include/deal.II/base/std_cxx11/thread.h @@ -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 + +#ifdef DEAL_II_WITH_CXX11 + +# include +DEAL_II_NAMESPACE_OPEN +namespace std_cxx11 +{ + using std::thread; +} +DEAL_II_NAMESPACE_CLOSE + +#else + +# include +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 index 0000000000..e5c6371b03 --- /dev/null +++ b/include/deal.II/base/std_cxx11/tuple.h @@ -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 + +#ifdef DEAL_II_WITH_CXX11 + +# include +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 +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 + struct tuple_size + { + static const std::size_t value = boost::tuples::length::value; + }; + + // similarly, boost::tuples::element has + // been renamed by the standard to + // std::tuple_element + template + struct tuple_element + { + typedef typename boost::tuples::element::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 index 0000000000..ee98aee8e3 --- /dev/null +++ b/include/deal.II/base/std_cxx11/type_traits.h @@ -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 + +#ifdef DEAL_II_WITH_CXX11 + +# include +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 +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 + struct is_standard_layout + { + static const bool value = boost::is_pod::value; + }; + + template + struct is_trivial + { + static const bool value = boost::has_trivial_copy::value && + boost::has_trivial_assign::value && + boost::has_trivial_constructor::value && + boost::has_trivial_destructor::value; + }; +} +DEAL_II_NAMESPACE_CLOSE + +#endif + +#endif diff --git a/include/deal.II/base/std_cxx1x/array.h b/include/deal.II/base/std_cxx1x/array.h index 22635ef086..326a74e5f4 100644 --- a/include/deal.II/base/std_cxx1x/array.h +++ b/include/deal.II/base/std_cxx1x/array.h @@ -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. // @@ -14,32 +14,8 @@ // // --------------------------------------------------------------------- -#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 - -#ifdef DEAL_II_WITH_CXX11 - -# include -DEAL_II_NAMESPACE_OPEN -namespace std_cxx1x -{ - using std::array; -} -DEAL_II_NAMESPACE_CLOSE - -#else - -#include -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; diff --git a/include/deal.II/base/std_cxx1x/bind.h b/include/deal.II/base/std_cxx1x/bind.h index 5868fda7d0..23efb3ad5d 100644 --- a/include/deal.II/base/std_cxx1x/bind.h +++ b/include/deal.II/base/std_cxx1x/bind.h @@ -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. // @@ -14,57 +14,8 @@ // // --------------------------------------------------------------------- -#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 - -#ifdef DEAL_II_WITH_CXX11 - -# include - -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 - -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; diff --git a/include/deal.II/base/std_cxx1x/condition_variable.h b/include/deal.II/base/std_cxx1x/condition_variable.h index 1927778f1f..dcfa4174cf 100644 --- a/include/deal.II/base/std_cxx1x/condition_variable.h +++ b/include/deal.II/base/std_cxx1x/condition_variable.h @@ -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. // @@ -14,36 +14,8 @@ // // --------------------------------------------------------------------- -#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 - -#ifdef DEAL_II_WITH_CXX11 - -# include -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 -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; diff --git a/include/deal.II/base/std_cxx1x/function.h b/include/deal.II/base/std_cxx1x/function.h index 0817258279..323ec32277 100644 --- a/include/deal.II/base/std_cxx1x/function.h +++ b/include/deal.II/base/std_cxx1x/function.h @@ -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. // @@ -14,32 +14,8 @@ // // --------------------------------------------------------------------- -#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 - -#ifdef DEAL_II_WITH_CXX11 - -# include -DEAL_II_NAMESPACE_OPEN -namespace std_cxx1x -{ - using std::function; -} -DEAL_II_NAMESPACE_CLOSE - -#else - -#include -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; diff --git a/include/deal.II/base/std_cxx1x/mutex.h b/include/deal.II/base/std_cxx1x/mutex.h index e8b40a54e2..a68030ce80 100644 --- a/include/deal.II/base/std_cxx1x/mutex.h +++ b/include/deal.II/base/std_cxx1x/mutex.h @@ -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. // @@ -14,32 +14,8 @@ // // --------------------------------------------------------------------- -#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 - -#ifdef DEAL_II_WITH_CXX11 - -# include -DEAL_II_NAMESPACE_OPEN -namespace std_cxx1x -{ - using std::mutex; -} -DEAL_II_NAMESPACE_CLOSE - -#else - -# include -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; diff --git a/include/deal.II/base/std_cxx1x/shared_ptr.h b/include/deal.II/base/std_cxx1x/shared_ptr.h index 78f6701cab..d797613859 100644 --- a/include/deal.II/base/std_cxx1x/shared_ptr.h +++ b/include/deal.II/base/std_cxx1x/shared_ptr.h @@ -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. // @@ -14,35 +14,8 @@ // // --------------------------------------------------------------------- -#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 - -#ifdef DEAL_II_WITH_CXX11 - -# include -DEAL_II_NAMESPACE_OPEN -namespace std_cxx1x -{ - using std::shared_ptr; - using std::enable_shared_from_this; -} -DEAL_II_NAMESPACE_CLOSE - -#else - -#include -#include -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; diff --git a/include/deal.II/base/std_cxx1x/thread.h b/include/deal.II/base/std_cxx1x/thread.h index 2dccd96d78..16c428db0c 100644 --- a/include/deal.II/base/std_cxx1x/thread.h +++ b/include/deal.II/base/std_cxx1x/thread.h @@ -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. // @@ -14,32 +14,8 @@ // // --------------------------------------------------------------------- -#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 - -#ifdef DEAL_II_WITH_CXX11 - -# include -DEAL_II_NAMESPACE_OPEN -namespace std_cxx1x -{ - using std::thread; -} -DEAL_II_NAMESPACE_CLOSE - -#else - -# include -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; diff --git a/include/deal.II/base/std_cxx1x/tuple.h b/include/deal.II/base/std_cxx1x/tuple.h index 4a23a3d441..162ee54a3c 100644 --- a/include/deal.II/base/std_cxx1x/tuple.h +++ b/include/deal.II/base/std_cxx1x/tuple.h @@ -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. // @@ -14,53 +14,8 @@ // // --------------------------------------------------------------------- -#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 - -#ifdef DEAL_II_WITH_CXX11 - -# include -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 -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 - struct tuple_size - { - static const std::size_t value = boost::tuples::length::value; - }; - - // similarly, boost::tuples::element has - // been renamed by the standard to - // std::tuple_element - template - struct tuple_element - { - typedef typename boost::tuples::element::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; diff --git a/include/deal.II/base/std_cxx1x/type_traits.h b/include/deal.II/base/std_cxx1x/type_traits.h index d2084bb48b..aba163a535 100644 --- a/include/deal.II/base/std_cxx1x/type_traits.h +++ b/include/deal.II/base/std_cxx1x/type_traits.h @@ -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. // @@ -14,54 +14,9 @@ // // --------------------------------------------------------------------- -#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 - -#ifdef DEAL_II_WITH_CXX11 - -# include -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 -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 - struct is_standard_layout - { - static const bool value = boost::is_pod::value; - }; - - template - struct is_trivial - { - static const bool value = boost::has_trivial_copy::value && - boost::has_trivial_assign::value && - boost::has_trivial_constructor::value && - boost::has_trivial_destructor::value; - }; -} -DEAL_II_NAMESPACE_CLOSE - -#endif - -#endif diff --git a/include/deal.II/base/synchronous_iterator.h b/include/deal.II/base/synchronous_iterator.h index 14b40192ba..3c2aef80bd 100644 --- a/include/deal.II/base/synchronous_iterator.h +++ b/include/deal.II/base/synchronous_iterator.h @@ -21,7 +21,7 @@ #include #include -#include +#include #include @@ -44,7 +44,7 @@ DEAL_II_NAMESPACE_OPEN * * The template argument of the current * class shall be of type - * std_cxx1x::tuple with + * std_cxx11::tuple with * arguments equal to the iterator types. * * This type, and the helper functions @@ -110,7 +110,7 @@ bool operator< (const SynchronousIterators &a, const SynchronousIterators &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 &a, const SynchronousIterators &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 &a, */ template inline -void advance (std_cxx1x::tuple &t, +void advance (std_cxx11::tuple &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 &t, */ template inline -void advance (std_cxx1x::tuple &t, +void advance (std_cxx11::tuple &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 &t, template inline -void advance (std_cxx1x::tuple &t, +void advance (std_cxx11::tuple &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 &t, */ template inline -void advance_by_one (std_cxx1x::tuple &t) +void advance_by_one (std_cxx11::tuple &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 &t) */ template inline -void advance_by_one (std_cxx1x::tuple &t) +void advance_by_one (std_cxx11::tuple &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 &t) template inline -void advance_by_one (std_cxx1x::tuple &t) +void advance_by_one (std_cxx11::tuple &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 &a, const SynchronousIterators &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 diff --git a/include/deal.II/base/thread_management.h b/include/deal.II/base/thread_management.h index 337e0933f9..635beef1bb 100644 --- a/include/deal.II/base/thread_management.h +++ b/include/deal.II/base/thread_management.h @@ -21,15 +21,15 @@ #include #include #include -#include -#include -#include -#include +#include +#include +#include +#include #ifdef DEAL_II_WITH_THREADS -# include -# include -# include +# include +# include +# include #endif #include @@ -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 lock(mutex.mutex, - std_cxx1x::adopt_lock); + std_cxx11::unique_lock 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 - inline void call (const std_cxx1x::function &function, + inline void call (const std_cxx11::function &function, internal::return_value &ret_val) { ret_val.set (function()); } - inline void call (const std_cxx1x::function &function, + inline void call (const std_cxx11::function &function, internal::return_value &) { function(); @@ -1034,7 +1034,7 @@ namespace Threads * for each number of arguments. */ template ::value> + int length = std_cxx11::tuple_size::value> struct fun_ptr_helper; @@ -1062,7 +1062,7 @@ namespace Threads template struct fun_ptr_helper { - 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 struct fun_ptr_helper { - 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 struct fun_ptr_helper { - 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 struct fun_ptr_helper { - 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 struct fun_ptr_helper { - 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 struct fun_ptr_helper { - 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 struct fun_ptr_helper { - 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 struct fun_ptr_helper { - 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 struct fun_ptr_helper { - 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 struct fun_ptr_helper { - 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 > ret_val; + std_cxx11::shared_ptr > 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 &function) + void start (const std_cxx11::function &function) { thread_is_active = true; ret_val.reset(new return_value()); - 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 function, - std_cxx1x::shared_ptr > ret_val) + void thread_entry_point (const std_cxx11::function function, + std_cxx11::shared_ptr > 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 > ret_val; + std_cxx11::shared_ptr > ret_val; /** * Start the thread and * let it put its return value into * the ret_val object. */ - void start (const std_cxx1x::function &function) + void start (const std_cxx11::function &function) { ret_val.reset(new return_value()); call (function, *ret_val); @@ -1546,7 +1546,7 @@ namespace Threads * Construct a thread object * with a function object. */ - Thread (const std_cxx1x::function &function) + Thread (const std_cxx11::function &function) : thread_descriptor (new internal::ThreadDescriptor()) { @@ -1641,7 +1641,7 @@ namespace Threads * as long as there is at least * one subscriber to it. */ - std_cxx1x::shared_ptr > thread_descriptor; + std_cxx11::shared_ptr > 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 struct maybe_make_ref { - static std_cxx1x::reference_wrapper act (T &t) + static std_cxx11::reference_wrapper 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::type> &function) + fun_encapsulator (const std_cxx11::function::type> &function) : function (function) {} @@ -1745,7 +1745,7 @@ namespace Threads } private: - std_cxx1x::function::type> function; + std_cxx11::function::type> function; }; /** @@ -1761,22 +1761,22 @@ namespace Threads : function (*function) {} - fun_encapsulator (const std_cxx1x::function::type> &function) + fun_encapsulator (const std_cxx11::function::type> &function) : function (function) {} inline Thread - operator() (typename std_cxx1x::tuple_element<0,ArgList>::type arg1) + operator() (typename std_cxx11::tuple_element<0,ArgList>::type arg1) { return Thread - (std_cxx1x::bind (function, - internal::maybe_make_ref::type>::act(arg1))); + (std_cxx11::bind (function, + internal::maybe_make_ref::type>::act(arg1))); } private: - std_cxx1x::function::type> function; + std_cxx11::function::type> function; }; /** @@ -1792,24 +1792,24 @@ namespace Threads : function (*function) {} - fun_encapsulator (const std_cxx1x::function::type> &function) + fun_encapsulator (const std_cxx11::function::type> &function) : function (function) {} inline Thread - 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 - (std_cxx1x::bind (function, - internal::maybe_make_ref::type>::act(arg1), - internal::maybe_make_ref::type>::act(arg2))); + (std_cxx11::bind (function, + internal::maybe_make_ref::type>::act(arg1), + internal::maybe_make_ref::type>::act(arg2))); } private: - std_cxx1x::function::type> function; + std_cxx11::function::type> function; }; /** @@ -1825,26 +1825,26 @@ namespace Threads : function (*function) {} - fun_encapsulator (const std_cxx1x::function::type> &function) + fun_encapsulator (const std_cxx11::function::type> &function) : function (function) {} inline Thread - 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 - (std_cxx1x::bind (function, - internal::maybe_make_ref::type>::act(arg1), - internal::maybe_make_ref::type>::act(arg2), - internal::maybe_make_ref::type>::act(arg3))); + (std_cxx11::bind (function, + internal::maybe_make_ref::type>::act(arg1), + internal::maybe_make_ref::type>::act(arg2), + internal::maybe_make_ref::type>::act(arg3))); } private: - std_cxx1x::function::type> function; + std_cxx11::function::type> function; }; /** @@ -1860,28 +1860,28 @@ namespace Threads : function (*function) {} - fun_encapsulator (const std_cxx1x::function::type> &function) + fun_encapsulator (const std_cxx11::function::type> &function) : function (function) {} inline Thread - 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 - (std_cxx1x::bind (function, - internal::maybe_make_ref::type>::act(arg1), - internal::maybe_make_ref::type>::act(arg2), - internal::maybe_make_ref::type>::act(arg3), - internal::maybe_make_ref::type>::act(arg4))); + (std_cxx11::bind (function, + internal::maybe_make_ref::type>::act(arg1), + internal::maybe_make_ref::type>::act(arg2), + internal::maybe_make_ref::type>::act(arg3), + internal::maybe_make_ref::type>::act(arg4))); } private: - std_cxx1x::function::type> function; + std_cxx11::function::type> function; }; /** @@ -1897,30 +1897,30 @@ namespace Threads : function (*function) {} - fun_encapsulator (const std_cxx1x::function::type> &function) + fun_encapsulator (const std_cxx11::function::type> &function) : function (function) {} inline Thread - 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 - (std_cxx1x::bind (function, - internal::maybe_make_ref::type>::act(arg1), - internal::maybe_make_ref::type>::act(arg2), - internal::maybe_make_ref::type>::act(arg3), - internal::maybe_make_ref::type>::act(arg4), - internal::maybe_make_ref::type>::act(arg5))); + (std_cxx11::bind (function, + internal::maybe_make_ref::type>::act(arg1), + internal::maybe_make_ref::type>::act(arg2), + internal::maybe_make_ref::type>::act(arg3), + internal::maybe_make_ref::type>::act(arg4), + internal::maybe_make_ref::type>::act(arg5))); } private: - std_cxx1x::function::type> function; + std_cxx11::function::type> function; }; /** @@ -1936,32 +1936,32 @@ namespace Threads : function (*function) {} - fun_encapsulator (const std_cxx1x::function::type> &function) + fun_encapsulator (const std_cxx11::function::type> &function) : function (function) {} inline Thread - 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 - (std_cxx1x::bind (function, - internal::maybe_make_ref::type>::act(arg1), - internal::maybe_make_ref::type>::act(arg2), - internal::maybe_make_ref::type>::act(arg3), - internal::maybe_make_ref::type>::act(arg4), - internal::maybe_make_ref::type>::act(arg5), - internal::maybe_make_ref::type>::act(arg6))); + (std_cxx11::bind (function, + internal::maybe_make_ref::type>::act(arg1), + internal::maybe_make_ref::type>::act(arg2), + internal::maybe_make_ref::type>::act(arg3), + internal::maybe_make_ref::type>::act(arg4), + internal::maybe_make_ref::type>::act(arg5), + internal::maybe_make_ref::type>::act(arg6))); } private: - std_cxx1x::function::type> function; + std_cxx11::function::type> function; }; /** @@ -1977,34 +1977,34 @@ namespace Threads : function (*function) {} - fun_encapsulator (const std_cxx1x::function::type> &function) + fun_encapsulator (const std_cxx11::function::type> &function) : function (function) {} inline Thread - 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 - (std_cxx1x::bind (function, - internal::maybe_make_ref::type>::act(arg1), - internal::maybe_make_ref::type>::act(arg2), - internal::maybe_make_ref::type>::act(arg3), - internal::maybe_make_ref::type>::act(arg4), - internal::maybe_make_ref::type>::act(arg5), - internal::maybe_make_ref::type>::act(arg6), - internal::maybe_make_ref::type>::act(arg7))); + (std_cxx11::bind (function, + internal::maybe_make_ref::type>::act(arg1), + internal::maybe_make_ref::type>::act(arg2), + internal::maybe_make_ref::type>::act(arg3), + internal::maybe_make_ref::type>::act(arg4), + internal::maybe_make_ref::type>::act(arg5), + internal::maybe_make_ref::type>::act(arg6), + internal::maybe_make_ref::type>::act(arg7))); } private: - std_cxx1x::function::type> function; + std_cxx11::function::type> function; }; /** @@ -2020,36 +2020,36 @@ namespace Threads : function (*function) {} - fun_encapsulator (const std_cxx1x::function::type> &function) + fun_encapsulator (const std_cxx11::function::type> &function) : function (function) {} inline Thread - 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 - (std_cxx1x::bind (function, - internal::maybe_make_ref::type>::act(arg1), - internal::maybe_make_ref::type>::act(arg2), - internal::maybe_make_ref::type>::act(arg3), - internal::maybe_make_ref::type>::act(arg4), - internal::maybe_make_ref::type>::act(arg5), - internal::maybe_make_ref::type>::act(arg6), - internal::maybe_make_ref::type>::act(arg7), - internal::maybe_make_ref::type>::act(arg8))); + (std_cxx11::bind (function, + internal::maybe_make_ref::type>::act(arg1), + internal::maybe_make_ref::type>::act(arg2), + internal::maybe_make_ref::type>::act(arg3), + internal::maybe_make_ref::type>::act(arg4), + internal::maybe_make_ref::type>::act(arg5), + internal::maybe_make_ref::type>::act(arg6), + internal::maybe_make_ref::type>::act(arg7), + internal::maybe_make_ref::type>::act(arg8))); } private: - std_cxx1x::function::type> function; + std_cxx11::function::type> function; }; /** @@ -2065,38 +2065,38 @@ namespace Threads : function (*function) {} - fun_encapsulator (const std_cxx1x::function::type> &function) + fun_encapsulator (const std_cxx11::function::type> &function) : function (function) {} inline Thread - 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 - (std_cxx1x::bind (function, - internal::maybe_make_ref::type>::act(arg1), - internal::maybe_make_ref::type>::act(arg2), - internal::maybe_make_ref::type>::act(arg3), - internal::maybe_make_ref::type>::act(arg4), - internal::maybe_make_ref::type>::act(arg5), - internal::maybe_make_ref::type>::act(arg6), - internal::maybe_make_ref::type>::act(arg7), - internal::maybe_make_ref::type>::act(arg8), - internal::maybe_make_ref::type>::act(arg9))); + (std_cxx11::bind (function, + internal::maybe_make_ref::type>::act(arg1), + internal::maybe_make_ref::type>::act(arg2), + internal::maybe_make_ref::type>::act(arg3), + internal::maybe_make_ref::type>::act(arg4), + internal::maybe_make_ref::type>::act(arg5), + internal::maybe_make_ref::type>::act(arg6), + internal::maybe_make_ref::type>::act(arg7), + internal::maybe_make_ref::type>::act(arg8), + internal::maybe_make_ref::type>::act(arg9))); } private: - std_cxx1x::function::type> function; + std_cxx11::function::type> function; }; } @@ -2114,13 +2114,13 @@ namespace Threads */ template inline - internal::fun_encapsulator,0> + internal::fun_encapsulator,0> spawn (RT (*fun_ptr)()) DEAL_II_DEPRECATED; template inline - internal::fun_encapsulator,0> + internal::fun_encapsulator,0> spawn (RT (*fun_ptr)()) { return fun_ptr; @@ -2136,18 +2136,18 @@ namespace Threads */ template inline - internal::fun_encapsulator,0> + internal::fun_encapsulator,0> spawn (C &c, RT (C::*fun_ptr)()) DEAL_II_DEPRECATED; template inline - internal::fun_encapsulator,0> + internal::fun_encapsulator,0> spawn (C &c, RT (C::*fun_ptr)()) { return - std_cxx1x::function >::type> - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c))); + std_cxx11::function >::type> + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c))); } /** @@ -2159,18 +2159,18 @@ namespace Threads */ template inline - internal::fun_encapsulator,0> + internal::fun_encapsulator,0> spawn (const C &c, RT (C::*fun_ptr)() const) DEAL_II_DEPRECATED; template inline - internal::fun_encapsulator,0> + internal::fun_encapsulator,0> spawn (const C &c, RT (C::*fun_ptr)() const) { return - std_cxx1x::function >::type> - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c))); + std_cxx11::function >::type> + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c))); } @@ -2187,13 +2187,13 @@ namespace Threads */ template inline - internal::fun_encapsulator,1> + internal::fun_encapsulator,1> spawn (RT (*fun_ptr)(Arg1)) DEAL_II_DEPRECATED; template inline - internal::fun_encapsulator,1> + internal::fun_encapsulator,1> spawn (RT (*fun_ptr)(Arg1)) { return fun_ptr; @@ -2210,18 +2210,18 @@ namespace Threads */ template inline - internal::fun_encapsulator,1> + internal::fun_encapsulator,1> spawn (C &c, RT (C::*fun_ptr)(Arg1)) DEAL_II_DEPRECATED; template inline - internal::fun_encapsulator,1> + internal::fun_encapsulator,1> spawn (C &c, RT (C::*fun_ptr)(Arg1)) { return - std_cxx1x::function >::type> - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), std_cxx1x::_1)); + std_cxx11::function >::type> + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), std_cxx11::_1)); } /** @@ -2233,18 +2233,18 @@ namespace Threads */ template inline - internal::fun_encapsulator,1> + internal::fun_encapsulator,1> spawn (const C &c, RT (C::*fun_ptr)(Arg1) const) DEAL_II_DEPRECATED; template inline - internal::fun_encapsulator,1> + internal::fun_encapsulator,1> spawn (const C &c, RT (C::*fun_ptr)(Arg1) const) { return - std_cxx1x::function >::type> - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), std_cxx1x::_1)); + std_cxx11::function >::type> + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), std_cxx11::_1)); } @@ -2259,13 +2259,13 @@ namespace Threads */ template inline - internal::fun_encapsulator,2> + internal::fun_encapsulator,2> spawn (RT (*fun_ptr)(Arg1,Arg2)) DEAL_II_DEPRECATED; template inline - internal::fun_encapsulator,2> + internal::fun_encapsulator,2> spawn (RT (*fun_ptr)(Arg1,Arg2)) { return fun_ptr; @@ -2282,18 +2282,18 @@ namespace Threads */ template inline - internal::fun_encapsulator,2> + internal::fun_encapsulator,2> spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2)) DEAL_II_DEPRECATED; template inline - internal::fun_encapsulator,2> + internal::fun_encapsulator,2> spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2)) { return - std_cxx1x::function >::type> - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), std_cxx1x::_1, std_cxx1x::_2)); + std_cxx11::function >::type> + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), std_cxx11::_1, std_cxx11::_2)); } /** @@ -2305,18 +2305,18 @@ namespace Threads */ template inline - internal::fun_encapsulator,2> + internal::fun_encapsulator,2> spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2) const) DEAL_II_DEPRECATED; template inline - internal::fun_encapsulator,2> + internal::fun_encapsulator,2> spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2) const) { return - std_cxx1x::function >::type> - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), std_cxx1x::_1, std_cxx1x::_2)); + std_cxx11::function >::type> + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), std_cxx11::_1, std_cxx11::_2)); } @@ -2332,14 +2332,14 @@ namespace Threads template inline - internal::fun_encapsulator,3> + internal::fun_encapsulator,3> spawn (RT (*fun_ptr)(Arg1,Arg2,Arg3)) DEAL_II_DEPRECATED; template inline - internal::fun_encapsulator,3> + internal::fun_encapsulator,3> spawn (RT (*fun_ptr)(Arg1,Arg2,Arg3)) { return fun_ptr; @@ -2357,19 +2357,19 @@ namespace Threads template inline - internal::fun_encapsulator,3> + internal::fun_encapsulator,3> spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3)) DEAL_II_DEPRECATED; template inline - internal::fun_encapsulator,3> + internal::fun_encapsulator,3> spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3)) { return - std_cxx1x::function >::type> - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3)); + std_cxx11::function >::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 inline - internal::fun_encapsulator,3> + internal::fun_encapsulator,3> spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3) const) DEAL_II_DEPRECATED; template inline - internal::fun_encapsulator,3> + internal::fun_encapsulator,3> spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3) const) { return - std_cxx1x::function >::type> - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3)); + std_cxx11::function >::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 inline - internal::fun_encapsulator,4> + internal::fun_encapsulator,4> spawn (RT (*fun_ptr)(Arg1,Arg2,Arg3,Arg4)) DEAL_II_DEPRECATED; template inline - internal::fun_encapsulator,4> + internal::fun_encapsulator,4> spawn (RT (*fun_ptr)(Arg1,Arg2,Arg3,Arg4)) { return fun_ptr; @@ -2436,19 +2436,19 @@ namespace Threads template inline - internal::fun_encapsulator,4> + internal::fun_encapsulator,4> spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4)) DEAL_II_DEPRECATED; template inline - internal::fun_encapsulator,4> + internal::fun_encapsulator,4> spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4)) { return - std_cxx1x::function >::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 >::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 inline - internal::fun_encapsulator,4> + internal::fun_encapsulator,4> spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4) const) DEAL_II_DEPRECATED; template inline - internal::fun_encapsulator,4> + internal::fun_encapsulator,4> spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4) const) { return - std_cxx1x::function >::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 >::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,5> + internal::fun_encapsulator,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,5> + internal::fun_encapsulator,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,5> + internal::fun_encapsulator,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,5> + internal::fun_encapsulator,5> spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5)) { return - std_cxx1x::function >::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 >::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,5> + internal::fun_encapsulator,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,5> + internal::fun_encapsulator,5> spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5) const) { return - std_cxx1x::function >::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 >::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,6> + internal::fun_encapsulator,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,6> + internal::fun_encapsulator,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,6> + internal::fun_encapsulator,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,6> + internal::fun_encapsulator,6> spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,Arg6)) { return - std_cxx1x::function >::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 >::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,6> + std_cxx11::tuple,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,6> + std_cxx11::tuple,6> spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,Arg6) const) { return - std_cxx1x::function >::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 >::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,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,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,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,7> spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,Arg6,Arg7)) { return - std_cxx1x::function >::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 >::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,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,7> spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5,Arg6,Arg7) const) { return - std_cxx1x::function >::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 >::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,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,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,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,8> spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5, Arg6,Arg7,Arg8)) { return - std_cxx1x::function >::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 >::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,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,8> spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5, Arg6,Arg7,Arg8) const) { return - std_cxx1x::function >::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 >::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,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,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,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,9> spawn (C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5, Arg6,Arg7,Arg8,Arg9)) { return - std_cxx1x::function >::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 >::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,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,9> spawn (const C &c, RT (C::*fun_ptr)(Arg1,Arg2,Arg3,Arg4,Arg5, Arg6,Arg7,Arg8,Arg9) const) { return - std_cxx1x::function >::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 >::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, i.e. anything + * std_cxx11::function, 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 inline Thread - new_thread (const std_cxx1x::function &function) + new_thread (const std_cxx11::function &function) { return Thread(function); } @@ -3017,7 +3017,7 @@ namespace Threads { return Thread - (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 - (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 - (std_cxx1x::bind(fun_ptr, + (std_cxx11::bind(fun_ptr, internal::maybe_make_ref::act(arg1))); } @@ -3082,7 +3082,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), internal::maybe_make_ref::act(arg1))); } @@ -3103,7 +3103,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), internal::maybe_make_ref::act(arg1))); } #endif @@ -3126,7 +3126,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, + (std_cxx11::bind(fun_ptr, internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2))); } @@ -3150,7 +3150,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2))); } @@ -3173,7 +3173,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2))); } @@ -3199,7 +3199,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, + (std_cxx11::bind(fun_ptr, internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3))); @@ -3226,7 +3226,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3))); @@ -3252,7 +3252,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3))); @@ -3281,7 +3281,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, + (std_cxx11::bind(fun_ptr, internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -3310,7 +3310,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -3338,7 +3338,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -3369,7 +3369,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, + (std_cxx11::bind(fun_ptr, internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -3401,7 +3401,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -3432,7 +3432,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -3465,7 +3465,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, + (std_cxx11::bind(fun_ptr, internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -3499,7 +3499,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -3532,7 +3532,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -3568,7 +3568,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, + (std_cxx11::bind(fun_ptr, internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -3605,7 +3605,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -3641,7 +3641,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -3680,7 +3680,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, + (std_cxx11::bind(fun_ptr, internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -3720,7 +3720,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -3759,7 +3759,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -3800,7 +3800,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, + (std_cxx11::bind(fun_ptr, internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -3842,7 +3842,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -3883,7 +3883,7 @@ namespace Threads { return Thread - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -4047,7 +4047,7 @@ namespace Threads * The function and its arguments * that are to be run on the task. */ - std_cxx1x::function function; + std_cxx11::function 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 &function); + TaskDescriptor (const std_cxx11::function &function); /** * Default @@ -4147,7 +4147,7 @@ namespace Threads template inline - TaskDescriptor::TaskDescriptor (const std_cxx1x::function &function) + TaskDescriptor::TaskDescriptor (const std_cxx11::function &function) : function (function), task_is_done (false) @@ -4274,7 +4274,7 @@ namespace Threads * slot reserved for this * purpose. */ - TaskDescriptor (const std_cxx1x::function &function) + TaskDescriptor (const std_cxx11::function &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 &function_object) + Task (const std_cxx11::function &function_object) { // create a task descriptor and tell it // to queue itself up with the scheduling // system task_descriptor = - std_cxx1x::shared_ptr > + std_cxx11::shared_ptr > (new internal::TaskDescriptor(function_object)); task_descriptor->queue_task (); } @@ -4370,7 +4370,7 @@ namespace Threads void join () const { AssertThrow (task_descriptor != - std_cxx1x::shared_ptr >(), + std_cxx11::shared_ptr >(), ExcNoTask()); task_descriptor->join (); } @@ -4402,7 +4402,7 @@ namespace Threads bool operator == (const Task &t) { AssertThrow (task_descriptor != - std_cxx1x::shared_ptr >(), + std_cxx11::shared_ptr >(), 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 > task_descriptor; + std_cxx11::shared_ptr > task_descriptor; }; @@ -4432,7 +4432,7 @@ namespace Threads /** * Overload of the new_task function for * objects that can be converted to - * std_cxx1x::function, i.e. anything + * std_cxx11::function, 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 inline Task - new_task (const std_cxx1x::function &function) + new_task (const std_cxx11::function &function) { return Task(function); } @@ -4459,7 +4459,7 @@ namespace Threads Task new_task (RT (*fun_ptr)()) { - return new_task(std_cxx1x::function(fun_ptr)); + return new_task(std_cxx11::function(fun_ptr)); } @@ -4478,7 +4478,7 @@ namespace Threads { return new_task - (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 - (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 - (std_cxx1x::bind(fun_ptr, + (std_cxx11::bind(fun_ptr, internal::maybe_make_ref::act(arg1))); } @@ -4542,7 +4542,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), internal::maybe_make_ref::act(arg1))); } @@ -4563,7 +4563,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), internal::maybe_make_ref::act(arg1))); } #endif @@ -4586,7 +4586,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, + (std_cxx11::bind(fun_ptr, internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2))); } @@ -4610,7 +4610,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2))); } @@ -4633,7 +4633,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2))); } @@ -4659,7 +4659,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, + (std_cxx11::bind(fun_ptr, internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3))); @@ -4686,7 +4686,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3))); @@ -4712,7 +4712,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3))); @@ -4741,7 +4741,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, + (std_cxx11::bind(fun_ptr, internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -4770,7 +4770,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -4798,7 +4798,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -4829,7 +4829,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, + (std_cxx11::bind(fun_ptr, internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -4861,7 +4861,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -4892,7 +4892,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -4925,7 +4925,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, + (std_cxx11::bind(fun_ptr, internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -4959,7 +4959,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -4992,7 +4992,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -5028,7 +5028,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, + (std_cxx11::bind(fun_ptr, internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -5065,7 +5065,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -5101,7 +5101,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -5140,7 +5140,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, + (std_cxx11::bind(fun_ptr, internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -5180,7 +5180,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -5219,7 +5219,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -5260,7 +5260,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, + (std_cxx11::bind(fun_ptr, internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -5302,7 +5302,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, std_cxx1x::ref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::ref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), @@ -5343,7 +5343,7 @@ namespace Threads { return new_task - (std_cxx1x::bind(fun_ptr, std_cxx1x::cref(c), + (std_cxx11::bind(fun_ptr, std_cxx11::cref(c), internal::maybe_make_ref::act(arg1), internal::maybe_make_ref::act(arg2), internal::maybe_make_ref::act(arg3), diff --git a/include/deal.II/base/time_stepping.h b/include/deal.II/base/time_stepping.h index 079b4605b3..3e130eb95f 100644 --- a/include/deal.II/base/time_stepping.h +++ b/include/deal.II/base/time_stepping.h @@ -19,7 +19,7 @@ #include -#include +#include #include @@ -95,8 +95,8 @@ namespace TimeStepping * time step. */ virtual double evolve_one_time_step( - std::vector > &F, - std::vector > &J_inverse, + std::vector > &F, + std::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 > &F, - std::vector > &J_inverse, + std::vector > &F, + std::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 f, - std_cxx1x::function id_minus_tau_J_inverse, + std_cxx11::function f, + std_cxx11::function 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 f, - std_cxx1x::function id_minus_tau_J_inverse, + std_cxx11::function f, + std_cxx11::function 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 f, + double evolve_one_time_step(std_cxx11::function 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 f, + void compute_stages(std_cxx11::function 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 f, - std_cxx1x::function id_minus_tau_J_inverse, + std_cxx11::function f, + std_cxx11::function 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 f, - std_cxx1x::function id_minus_tau_J_inverse, + std_cxx11::function f, + std_cxx11::function 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 get_residual, - std_cxx1x::function id_minus_tau_J_inverse, + void newton_solve(std_cxx11::function get_residual, + std_cxx11::function id_minus_tau_J_inverse, VECTOR &y); /** * Compute the residual needed by the Newton solver. */ - void compute_residual(std_cxx1x::function f, + void compute_residual(std_cxx11::function 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 f, - std_cxx1x::function id_minus_tau_J_inverse, + std_cxx11::function f, + std_cxx11::function 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 f, + double evolve_one_time_step(std_cxx11::function 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 f, + void compute_stages(std_cxx11::function f, const double t, const double delta_t, const VECTOR &y, diff --git a/include/deal.II/base/time_stepping.templates.h b/include/deal.II/base/time_stepping.templates.h index a63e818b7a..27261d7ebd 100644 --- a/include/deal.II/base/time_stepping.templates.h +++ b/include/deal.II/base/time_stepping.templates.h @@ -17,7 +17,7 @@ #ifndef __deal2__time_stepping_templates_h #define __deal2__time_stepping_templates_h -#include +#include #include #include @@ -31,8 +31,9 @@ namespace TimeStepping template double RungeKutta::evolve_one_time_step( - std::vector > &F, - std::vector > &J_inverse, + std::vector > &F, + std::vector > &J_inverse, + double t, double delta_t, VECTOR &y) @@ -137,8 +138,8 @@ namespace TimeStepping template double ExplicitRungeKutta::evolve_one_time_step( - std_cxx1x::function f, - std_cxx1x::function id_minus_tau_J_inverse, + std_cxx11::function f, + std_cxx11::function id_minus_tau_J_inverse, double t, double delta_t, VECTOR &y) @@ -150,7 +151,7 @@ namespace TimeStepping template double ExplicitRungeKutta::evolve_one_time_step( - std_cxx1x::function f, + std_cxx11::function f, double t, double delta_t, VECTOR &y) @@ -178,7 +179,7 @@ namespace TimeStepping template void ExplicitRungeKutta::compute_stages( - std_cxx1x::function f, + std_cxx11::function f, const double t, const double delta_t, const VECTOR &y, @@ -280,8 +281,8 @@ namespace TimeStepping template double ImplicitRungeKutta::evolve_one_time_step( - std_cxx1x::function f, - std_cxx1x::function id_minus_tau_J_inverse, + std_cxx11::function f, + std_cxx11::function id_minus_tau_J_inverse, double t, double delta_t, VECTOR &y) @@ -323,8 +324,8 @@ namespace TimeStepping template void ImplicitRungeKutta::compute_stages( - std_cxx1x::function f, - std_cxx1x::function id_minus_tau_J_inverse, + std_cxx11::function f, + std_cxx11::function 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::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::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 void ImplicitRungeKutta::newton_solve( - std_cxx1x::function get_residual, - std_cxx1x::function id_minus_tau_J_inverse, + std_cxx11::function get_residual, + std_cxx11::function id_minus_tau_J_inverse, VECTOR &y) { VECTOR residual(y); @@ -376,7 +377,7 @@ namespace TimeStepping template void ImplicitRungeKutta::compute_residual( - std_cxx1x::function f, + std_cxx11::function f, double t, double delta_t, const VECTOR &old_y, @@ -673,8 +674,8 @@ namespace TimeStepping template double EmbeddedExplicitRungeKutta::evolve_one_time_step( - std_cxx1x::function f, - std_cxx1x::function id_minus_tau_J_inverse, + std_cxx11::function f, + std_cxx11::function id_minus_tau_J_inverse, double t, double delta_t, VECTOR &y) @@ -686,7 +687,7 @@ namespace TimeStepping template double EmbeddedExplicitRungeKutta::evolve_one_time_step( - std_cxx1x::function f, + std_cxx11::function f, double t, double delta_t, VECTOR &y) { bool done = false; @@ -801,7 +802,7 @@ namespace TimeStepping template void EmbeddedExplicitRungeKutta::compute_stages( - std_cxx1x::function f, + std_cxx11::function f, const double t, const double delta_t, const VECTOR &y, diff --git a/include/deal.II/base/work_stream.h b/include/deal.II/base/work_stream.h index ccbd6b6565..a4acdc1f0a 100644 --- a/include/deal.II/base/work_stream.h +++ b/include/deal.II/base/work_stream.h @@ -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 #include #include -#include -#include +#include +#include #include #include @@ -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 scratch_data; + std_cxx11::shared_ptr scratch_data; bool currently_in_use; /** @@ -504,7 +504,7 @@ namespace WorkStream * function that will do the * assembly. */ - Worker (const std_cxx1x::function &worker, bool copier_exist=true) @@ -623,7 +623,7 @@ namespace WorkStream * that does the assembling * on the sequence of cells. */ - const std_cxx1x::function worker; @@ -661,7 +661,7 @@ namespace WorkStream * the global matrix or * similar. */ - Copier (const std_cxx1x::function &copier) + Copier (const std_cxx11::function &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 copier; + const std_cxx11::function copier; }; } @@ -751,8 +751,8 @@ namespace WorkStream */ struct ScratchAndCopyDataObjects { - std_cxx1x::shared_ptr scratch_data; - std_cxx1x::shared_ptr copy_data; + std_cxx11::shared_ptr scratch_data; + std_cxx11::shared_ptr copy_data; bool currently_in_use; /** @@ -1032,10 +1032,10 @@ namespace WorkStream * function that will do the * assembly. */ - WorkerAndCopier (const std_cxx1x::function &worker, - const std_cxx1x::function &copier) + const std_cxx11::function &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 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 copier; + const std_cxx11::function copier; }; } @@ -1187,7 +1187,7 @@ namespace WorkStream /** * Constructor. */ - Worker (const std_cxx1x::function &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 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& >(worker)) worker (i, scratch_data, copy_data); - if (static_cast& > + if (static_cast& > (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& >(copier)) + if (static_cast& >(copier)) { // create the three stages of the pipeline internal::Implementation2::IteratorRangeToItemStream @@ -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& >(worker)) worker (*p, scratch_data, copy_data); - if (static_cast& >(copier)) + if (static_cast& >(copier)) copier (copy_data); } } @@ -1576,7 +1576,7 @@ namespace WorkStream for (unsigned int color=0; color 0) { - if (static_cast& >(copier)) + if (static_cast& >(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& >(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, diff --git a/include/deal.II/distributed/tria.h b/include/deal.II/distributed/tria.h index 740231ebe3..542e514898 100644 --- a/include/deal.II/distributed/tria.h +++ b/include/deal.II/distributed/tria.h @@ -24,8 +24,8 @@ #include #include -#include -#include +#include +#include #include #include @@ -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 + * #include * * template * void set_boundary_indicators (parallel::distributed::Triangulation &triangulation) @@ -249,13 +249,13 @@ namespace parallel * ... create the coarse mesh ... * * coarse_grid.signals.post_refinement.connect - * (std_cxx1x::bind (&set_boundary_indicators, - * std_cxx1x::ref(coarse_grid))); + * (std_cxx11::bind (&set_boundary_indicators, + * std_cxx11::ref(coarse_grid))); * * } * @endcode * - * What the call to std_cxx1x::bind does is to produce an object that + * What the call to std_cxx11::bind 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 MyClass class, then the following will work: * @code - * #include + * #include * * template * void @@ -289,9 +289,9 @@ namespace parallel * ... create the coarse mesh ... * * coarse_grid.signals.post_refinement.connect - * (std_cxx1x::bind (&MyGeometry::set_boundary_indicators, - * std_cxx1x::cref(*this), - * std_cxx1x::ref(coarse_grid))); + * (std_cxx11::bind (&MyGeometry::set_boundary_indicators, + * std_cxx11::cref(*this), + * std_cxx11::ref(coarse_grid))); * } * @endcode * Here, like any other member function, set_boundary_indicators @@ -673,7 +673,7 @@ namespace parallel */ unsigned int register_data_attach (const std::size_t size, - const std_cxx1x::function &pack_callback); @@ -693,7 +693,7 @@ namespace parallel */ void notify_ready_to_unpack (const unsigned int offset, - const std_cxx1x::function &unpack_callback); @@ -822,7 +822,7 @@ namespace parallel */ unsigned int n_attached_deserialize; - typedef std_cxx1x::function< + typedef std_cxx11::function< void(typename Triangulation::cell_iterator, CellStatus, void *) > pack_callback_t; diff --git a/include/deal.II/dofs/dof_handler.h b/include/deal.II/dofs/dof_handler.h index df011c759c..94d7e3169a 100644 --- a/include/deal.II/dofs/dof_handler.h +++ b/include/deal.II/dofs/dof_handler.h @@ -24,7 +24,7 @@ #include #include #include -#include +#include #include #include #include @@ -1109,7 +1109,7 @@ protected: * of freedom should be distributed and * renumbered. */ - std_cxx1x::shared_ptr > policy; + std_cxx11::shared_ptr > policy; /** * A structure that contains all diff --git a/include/deal.II/fe/fe_system.h b/include/deal.II/fe/fe_system.h index 362e113fa2..3d3836de31 100644 --- a/include/deal.II/fe/fe_system.h +++ b/include/deal.II/fe/fe_system.h @@ -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::vector >, unsigned int> > base_elements; diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h index 1eacc53dc0..f152816995 100644 --- a/include/deal.II/grid/tria.h +++ b/include/deal.II/grid/tria.h @@ -24,7 +24,7 @@ #include #include #include -#include +#include #include #include #include @@ -1029,8 +1029,8 @@ namespace internal * // mesh refinement * previous_cell = current_cell; * previous_cell.get_tria().signals.post_refinement - * .connect (std_cxx1x::bind (&FEValues::invalidate_previous_cell, - * std_cxx1x::ref (*this))); + * .connect (std_cxx11::bind (&FEValues::invalidate_previous_cell, + * std_cxx11::ref (*this))); * } * else * previous_cell = current_cell; diff --git a/include/deal.II/grid/tria_boundary.h b/include/deal.II/grid/tria_boundary.h index 9ee79ac5e7..cb2835ae5d 100644 --- a/include/deal.II/grid/tria_boundary.h +++ b/include/deal.II/grid/tria_boundary.h @@ -269,7 +269,7 @@ private: /** * Point generator for the intermediate points on a boundary. */ - mutable std::vector > > points; + mutable std::vector > > points; /** * Mutex for protecting the points array. diff --git a/include/deal.II/hp/fe_collection.h b/include/deal.II/hp/fe_collection.h index def9cc371e..7139937b26 100644 --- a/include/deal.II/hp/fe_collection.h +++ b/include/deal.II/hp/fe_collection.h @@ -18,7 +18,7 @@ #define __deal2__fe_collection_h #include -#include +#include #include #include #include @@ -438,7 +438,7 @@ namespace hp * Array of pointers to the finite * elements stored by this collection. */ - std::vector > > finite_elements; + std::vector > > finite_elements; }; diff --git a/include/deal.II/hp/fe_values.h b/include/deal.II/hp/fe_values.h index c4d14caa6d..cc00c03ebf 100644 --- a/include/deal.II/hp/fe_values.h +++ b/include/deal.II/hp/fe_values.h @@ -25,7 +25,7 @@ #include #include -#include +#include 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 > fe_values_table; + dealii::Table<3,std_cxx11::shared_ptr > fe_values_table; /** * Set of indices pointing at the fe_values object selected last time diff --git a/include/deal.II/hp/mapping_collection.h b/include/deal.II/hp/mapping_collection.h index e187cfdc35..82ca73477c 100644 --- a/include/deal.II/hp/mapping_collection.h +++ b/include/deal.II/hp/mapping_collection.h @@ -23,7 +23,7 @@ #include #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -132,7 +132,7 @@ namespace hp * pointers to the different Mapping * objects. */ - std::vector > > mappings; + std::vector > > mappings; }; diff --git a/include/deal.II/hp/q_collection.h b/include/deal.II/hp/q_collection.h index 2b556ddb26..15e4a9846e 100644 --- a/include/deal.II/hp/q_collection.h +++ b/include/deal.II/hp/q_collection.h @@ -24,7 +24,7 @@ #include #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -149,7 +149,7 @@ namespace hp * pointers to the different quadrature * objects. */ - std::vector > > quadratures; + std::vector > > quadratures; }; @@ -208,7 +208,7 @@ namespace hp QCollection::QCollection (const Quadrature &quadrature) { quadratures - .push_back (std_cxx1x::shared_ptr >(new Quadrature(quadrature))); + .push_back (std_cxx11::shared_ptr >(new Quadrature(quadrature))); } @@ -251,7 +251,7 @@ namespace hp QCollection::push_back (const Quadrature &new_quadrature) { quadratures - .push_back (std_cxx1x::shared_ptr >(new Quadrature(new_quadrature))); + .push_back (std_cxx11::shared_ptr >(new Quadrature(new_quadrature))); } } // namespace hp diff --git a/include/deal.II/lac/chunk_sparse_matrix.templates.h b/include/deal.II/lac/chunk_sparse_matrix.templates.h index bc7f6a323a..1a241b42d7 100644 --- a/include/deal.II/lac/chunk_sparse_matrix.templates.h +++ b/include/deal.II/lac/chunk_sparse_matrix.templates.h @@ -404,9 +404,9 @@ ChunkSparseMatrix::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, - 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::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 , - 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); } diff --git a/include/deal.II/lac/filtered_matrix.h b/include/deal.II/lac/filtered_matrix.h index 074613fc5f..a73c4aeefc 100644 --- a/include/deal.II/lac/filtered_matrix.h +++ b/include/deal.II/lac/filtered_matrix.h @@ -617,7 +617,7 @@ private: * pattern used for this * matrix. */ - std_cxx1x::shared_ptr > matrix; + std_cxx11::shared_ptr > matrix; /** * Sorted list of pairs denoting diff --git a/include/deal.II/lac/iterative_inverse.h b/include/deal.II/lac/iterative_inverse.h index 0fe4432028..ef2c71006d 100644 --- a/include/deal.II/lac/iterative_inverse.h +++ b/include/deal.II/lac/iterative_inverse.h @@ -118,12 +118,12 @@ private: /** * The matrix in use. */ - std_cxx1x::shared_ptr > matrix; + std_cxx11::shared_ptr > matrix; /** * The preconditioner to use. */ - std_cxx1x::shared_ptr > preconditioner; + std_cxx11::shared_ptr > preconditioner; }; @@ -135,8 +135,8 @@ IterativeInverse::initialize(const MATRIX &m, const PRECONDITION &p) { // dummy variable VECTOR *v = 0; - matrix = std_cxx1x::shared_ptr > (new_pointer_matrix_base(m, *v)); - preconditioner = std_cxx1x::shared_ptr > (new_pointer_matrix_base(p, *v)); + matrix = std_cxx11::shared_ptr > (new_pointer_matrix_base(m, *v)); + preconditioner = std_cxx11::shared_ptr > (new_pointer_matrix_base(p, *v)); } diff --git a/include/deal.II/lac/lapack_full_matrix.h b/include/deal.II/lac/lapack_full_matrix.h index ecf8c9132c..30be840792 100644 --- a/include/deal.II/lac/lapack_full_matrix.h +++ b/include/deal.II/lac/lapack_full_matrix.h @@ -24,7 +24,7 @@ #include #include -#include +#include #include #include @@ -638,13 +638,13 @@ private: * The matrix U in the singular value decomposition * USVT. */ - std_cxx1x::shared_ptr > svd_u; + std_cxx11::shared_ptr > svd_u; /** * The matrix VT in the singular value decomposition * USVT. */ - std_cxx1x::shared_ptr > svd_vt; + std_cxx11::shared_ptr > svd_vt; }; diff --git a/include/deal.II/lac/matrix_block.h b/include/deal.II/lac/matrix_block.h index b72414d085..df119e725d 100644 --- a/include/deal.II/lac/matrix_block.h +++ b/include/deal.II/lac/matrix_block.h @@ -20,7 +20,7 @@ #include #include #include -#include +#include #include #include #include @@ -415,7 +415,7 @@ private: template class MatrixBlockVector : - private NamedData > > + private NamedData > > { public: /** @@ -490,10 +490,10 @@ public: /** * import functions from private base class */ - using NamedData >::subscribe; - using NamedData >::unsubscribe; - using NamedData >::size; - using NamedData >::name; + using NamedData >::subscribe; + using NamedData >::unsubscribe; + using NamedData >::size; + using NamedData >::name; }; @@ -956,8 +956,8 @@ MatrixBlockVector::add( size_type row, size_type column, const std::string &name) { - std_cxx1x::shared_ptr p(new value_type(row, column)); - NamedData >::add(p, name); + std_cxx11::shared_ptr p(new value_type(row, column)); + NamedData >::add(p, name); } diff --git a/include/deal.II/lac/parallel_vector.h b/include/deal.II/lac/parallel_vector.h index 44c91f1745..b58809d97e 100644 --- a/include/deal.II/lac/parallel_vector.h +++ b/include/deal.II/lac/parallel_vector.h @@ -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 &partitioner); + Vector (const std_cxx11::shared_ptr &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 &partitioner); + void reinit (const std_cxx11::shared_ptr &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 partitioner; + std_cxx11::shared_ptr partitioner; /** * The size that is currently allocated in the val array. @@ -1177,7 +1177,7 @@ namespace parallel template inline Vector:: - Vector (const std_cxx1x::shared_ptr &partitioner) + Vector (const std_cxx11::shared_ptr &partitioner) : allocated_size (0), val (0), diff --git a/include/deal.II/lac/parallel_vector.templates.h b/include/deal.II/lac/parallel_vector.templates.h index 1301658d91..6438050572 100644 --- a/include/deal.II/lac/parallel_vector.templates.h +++ b/include/deal.II/lac/parallel_vector.templates.h @@ -153,7 +153,7 @@ namespace parallel const MPI_Comm communicator) { // set up parallel partitioner with index sets and communicator - std_cxx1x::shared_ptr new_partitioner + std_cxx11::shared_ptr 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 new_partitioner + std_cxx11::shared_ptr new_partitioner (new Utilities::MPI::Partitioner (locally_owned_indices, ghost_indices, communicator)); reinit (new_partitioner); @@ -178,7 +178,7 @@ namespace parallel template void - Vector::reinit (const std_cxx1x::shared_ptr &partitioner_in) + Vector::reinit (const std_cxx11::shared_ptr &partitioner_in) { clear_mpi_requests(); partitioner = partitioner_in; diff --git a/include/deal.II/lac/petsc_matrix_base.h b/include/deal.II/lac/petsc_matrix_base.h index 870647f24c..26bc96deec 100644 --- a/include/deal.II/lac/petsc_matrix_base.h +++ b/include/deal.II/lac/petsc_matrix_base.h @@ -28,7 +28,7 @@ # include # include -# include +# include # include # include @@ -169,13 +169,13 @@ namespace PETScWrappers * accessor can access this data * if necessary. */ - std_cxx1x::shared_ptr > colnum_cache; + std_cxx11::shared_ptr > colnum_cache; /** * Similar cache for the values * of this row. */ - std_cxx1x::shared_ptr > value_cache; + std_cxx11::shared_ptr > value_cache; /** * Discard the old row caches diff --git a/include/deal.II/lac/petsc_solver.h b/include/deal.II/lac/petsc_solver.h index b87797cd4f..7685f2c83b 100644 --- a/include/deal.II/lac/petsc_solver.h +++ b/include/deal.II/lac/petsc_solver.h @@ -24,7 +24,7 @@ # include # include -# include +# include # include @@ -280,7 +280,7 @@ namespace PETScWrappers * the main solver routine if * necessary. */ - std_cxx1x::shared_ptr solver_data; + std_cxx11::shared_ptr solver_data; }; @@ -1242,7 +1242,7 @@ namespace PETScWrappers PC pc; }; - std_cxx1x::shared_ptr solver_data; + std_cxx11::shared_ptr solver_data; /** * Flag specifies whether matrix diff --git a/include/deal.II/lac/slepc_solver.h b/include/deal.II/lac/slepc_solver.h index ded75613d4..73ab3f4ca0 100644 --- a/include/deal.II/lac/slepc_solver.h +++ b/include/deal.II/lac/slepc_solver.h @@ -22,7 +22,7 @@ #ifdef DEAL_II_WITH_SLEPC -# include +# include # include # include # include @@ -425,7 +425,7 @@ namespace SLEPcWrappers /** * Pointer to the SolverData object. */ - std_cxx1x::shared_ptr solver_data; + std_cxx11::shared_ptr solver_data; }; /** diff --git a/include/deal.II/lac/slepc_spectral_transformation.h b/include/deal.II/lac/slepc_spectral_transformation.h index 4449b2e41e..83de2f06c7 100644 --- a/include/deal.II/lac/slepc_spectral_transformation.h +++ b/include/deal.II/lac/slepc_spectral_transformation.h @@ -23,7 +23,7 @@ #ifdef DEAL_II_WITH_SLEPC -# include +# include # include # include @@ -117,7 +117,7 @@ namespace SLEPcWrappers ST st; }; - std_cxx1x::shared_ptr transformation_data; + std_cxx11::shared_ptr transformation_data; }; /** diff --git a/include/deal.II/lac/sparse_matrix.templates.h b/include/deal.II/lac/sparse_matrix.templates.h index 4c410ed5ed..e5490c145e 100644 --- a/include/deal.II/lac/sparse_matrix.templates.h +++ b/include/deal.II/lac/sparse_matrix.templates.h @@ -38,7 +38,7 @@ #include #include #include -#include +#include @@ -164,9 +164,9 @@ SparseMatrix::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, - 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::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 , - 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::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 , - 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::matrix_norm_square (const Vector &v) const return parallel::accumulate_from_subranges - (std_cxx1x::bind (&internal::SparseMatrix::matrix_norm_sqr_on_subrange + (std_cxx11::bind (&internal::SparseMatrix::matrix_norm_sqr_on_subrange >, - 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::matrix_scalar_product (const Vector &u, return parallel::accumulate_from_subranges - (std_cxx1x::bind (&internal::SparseMatrix::matrix_scalar_product_on_subrange + (std_cxx11::bind (&internal::SparseMatrix::matrix_scalar_product_on_subrange >, - 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::residual (Vector &dst, return std::sqrt (parallel::accumulate_from_subranges - (std_cxx1x::bind (&internal::SparseMatrix::residual_sqr_on_subrange + (std_cxx11::bind (&internal::SparseMatrix::residual_sqr_on_subrange ,Vector >, - 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)); } diff --git a/include/deal.II/lac/trilinos_precondition.h b/include/deal.II/lac/trilinos_precondition.h index 8877d031df..8e282b1a24 100644 --- a/include/deal.II/lac/trilinos_precondition.h +++ b/include/deal.II/lac/trilinos_precondition.h @@ -23,7 +23,7 @@ #ifdef DEAL_II_WITH_TRILINOS # include -# include +# include # include # include @@ -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 preconditioner; + std_cxx11::shared_ptr 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 vector_distributor; + std_cxx11::shared_ptr vector_distributor; }; @@ -1557,7 +1557,7 @@ namespace TrilinosWrappers /** * A copy of the deal.II matrix into Trilinos format. */ - std_cxx1x::shared_ptr trilinos_matrix; + std_cxx11::shared_ptr trilinos_matrix; }; diff --git a/include/deal.II/lac/trilinos_solver.h b/include/deal.II/lac/trilinos_solver.h index 4a47aec813..42f39c18fc 100644 --- a/include/deal.II/lac/trilinos_solver.h +++ b/include/deal.II/lac/trilinos_solver.h @@ -22,7 +22,7 @@ #ifdef DEAL_II_WITH_TRILINOS -# include +# include # include # include # include @@ -243,7 +243,7 @@ namespace TrilinosWrappers * side vector and the solution vector, which is passed down to the * Trilinos solver. */ - std_cxx1x::shared_ptr linear_problem; + std_cxx11::shared_ptr 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 linear_problem; + std_cxx11::shared_ptr linear_problem; /** * A structure that contains the Trilinos solver and preconditioner * objects. */ - std_cxx1x::shared_ptr solver; + std_cxx11::shared_ptr solver; /** * Store a copy of the flags for this particular solver. diff --git a/include/deal.II/lac/trilinos_sparse_matrix.h b/include/deal.II/lac/trilinos_sparse_matrix.h index 467b60fed3..5484aa62e6 100644 --- a/include/deal.II/lac/trilinos_sparse_matrix.h +++ b/include/deal.II/lac/trilinos_sparse_matrix.h @@ -22,7 +22,7 @@ #ifdef DEAL_II_WITH_TRILINOS -# include +# include # include # include # include @@ -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 > colnum_cache; + std_cxx11::shared_ptr > colnum_cache; /** * Cache for the values of this row. */ - std_cxx1x::shared_ptr > value_cache; + std_cxx11::shared_ptr > 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 column_space_map; + std_cxx11::shared_ptr 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 matrix; + std_cxx11::shared_ptr 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 nonlocal_matrix; + std_cxx11::shared_ptr nonlocal_matrix; /** * An export object used to communicate the nonlocal matrix. */ - std_cxx1x::shared_ptr nonlocal_matrix_exporter; + std_cxx11::shared_ptr nonlocal_matrix_exporter; /** * Trilinos doesn't allow to mix additions to matrix entries and diff --git a/include/deal.II/lac/trilinos_sparsity_pattern.h b/include/deal.II/lac/trilinos_sparsity_pattern.h index 355aa2131c..d722c5e844 100644 --- a/include/deal.II/lac/trilinos_sparsity_pattern.h +++ b/include/deal.II/lac/trilinos_sparsity_pattern.h @@ -30,7 +30,7 @@ # include # include -# include +# include # include # include @@ -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 > colnum_cache; + std_cxx11::shared_ptr > 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 column_space_map; + std_cxx11::shared_ptr 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 graph; + std_cxx11::shared_ptr 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 nonlocal_graph; + std_cxx11::shared_ptr nonlocal_graph; friend class SparseMatrix; friend class SparsityPatternIterators::Accessor; diff --git a/include/deal.II/lac/trilinos_vector.h b/include/deal.II/lac/trilinos_vector.h index 951d660755..d130582772 100644 --- a/include/deal.II/lac/trilinos_vector.h +++ b/include/deal.II/lac/trilinos_vector.h @@ -22,7 +22,7 @@ #ifdef DEAL_II_WITH_TRILINOS -# include +# include # include # include # include diff --git a/include/deal.II/lac/trilinos_vector_base.h b/include/deal.II/lac/trilinos_vector_base.h index 27e3ffdab7..267254275b 100644 --- a/include/deal.II/lac/trilinos_vector_base.h +++ b/include/deal.II/lac/trilinos_vector_base.h @@ -23,7 +23,7 @@ #ifdef DEAL_II_WITH_TRILINOS #include -# include +# include # include # include # include @@ -898,14 +898,14 @@ namespace TrilinosWrappers * object requires an existing Epetra_Map for * storing data when setting it up. */ - std_cxx1x::shared_ptr vector; + std_cxx11::shared_ptr 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 nonlocal_vector; + std_cxx11::shared_ptr nonlocal_vector; /** * Make the reference class a friend. diff --git a/include/deal.II/lac/vector.templates.h b/include/deal.II/lac/vector.templates.h index f7a21e851e..f056e6acd5 100644 --- a/include/deal.II/lac/vector.templates.h +++ b/include/deal.II/lac/vector.templates.h @@ -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 , - 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::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, - 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(s, 0U, vec_size, *this); diff --git a/include/deal.II/matrix_free/dof_info.h b/include/deal.II/matrix_free/dof_info.h index 6fdc4f4928..9ea4a9266a 100644 --- a/include/deal.II/matrix_free/dof_info.h +++ b/include/deal.II/matrix_free/dof_info.h @@ -26,7 +26,7 @@ #include #include -#include +#include #include @@ -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 > row_starts; + std::vector > 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 vector_partitioner; + std_cxx11::shared_ptr vector_partitioner; /** * This stores a (sorted) list of all locally owned degrees of freedom diff --git a/include/deal.II/matrix_free/dof_info.templates.h b/include/deal.II/matrix_free/dof_info.templates.h index b2e737ca11..702fc65f28 100644 --- a/include/deal.II/matrix_free/dof_info.templates.h +++ b/include/deal.II/matrix_free/dof_info.templates.h @@ -609,7 +609,7 @@ no_constraint: std::swap (new_active_fe_index, cell_active_fe_index); } - std::vector > new_row_starts; + std::vector > new_row_starts; std::vector new_dof_indices; std::vector > 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)); + memory += (row_starts.capacity()*sizeof(std_cxx11::array)); 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))); + (out, (row_starts.capacity()*sizeof(std_cxx11::array))); out << " Memory dof indices: "; size_info.print_memory_statistics (out, MemoryConsumption::memory_consumption (dof_indices)); diff --git a/include/deal.II/matrix_free/fe_evaluation.h b/include/deal.II/matrix_free/fe_evaluation.h index 0cb1c0e0ae..5e6373465f 100644 --- a/include/deal.II/matrix_free/fe_evaluation.h +++ b/include/deal.II/matrix_free/fe_evaluation.h @@ -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 > stored_shape_info; + std_cxx11::shared_ptr > stored_shape_info; /** * Stores a pointer to the unit cell shape data, i.e., values, gradients and diff --git a/include/deal.II/matrix_free/mapping_info.templates.h b/include/deal.II/matrix_free/mapping_info.templates.h index f93060e5b7..09171dbcb0 100644 --- a/include/deal.II/matrix_free/mapping_info.templates.h +++ b/include/deal.II/matrix_free/mapping_info.templates.h @@ -241,7 +241,7 @@ namespace internal // hp::DoFHandler::active_cell_iterator, we need to manually // select the correct finite element, so just hold a vector of // FEValues - std::vector > > + std::vector > > fe_values (current_data.quadrature.size()); UpdateFlags update_flags_feval = (update_flags & update_inverse_jacobians ? update_jacobians : update_default) | diff --git a/include/deal.II/matrix_free/matrix_free.h b/include/deal.II/matrix_free/matrix_free.h index b7cbb6a017..4220406ba3 100644 --- a/include/deal.II/matrix_free/matrix_free.h +++ b/include/deal.II/matrix_free/matrix_free.h @@ -438,7 +438,7 @@ public: * to the function object. */ template - void cell_loop (const std_cxx1x::function &, + void cell_loop (const std_cxx11::function &, OutVector &, const InVector &, const std::paircell_operation (const MatrixFree &, OutVector * &, InVector &, std::pair&)const. 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 std_cxx11::shared_ptr & get_vector_partitioner (const unsigned int vector_component=0) const; /** @@ -968,7 +968,7 @@ MatrixFree::initialize_dof_vector(parallel::distributed::Vector inline -const std_cxx1x::shared_ptr & +const std_cxx11::shared_ptr & MatrixFree::get_vector_partitioner (const unsigned int comp) const { AssertIndexRange (comp, n_components()); @@ -2231,7 +2231,7 @@ template inline void MatrixFree::cell_loop -(const std_cxx1x::function &, +(const std_cxx11::function &, OutVector &, const InVector &, const std::pair::cell_loop // to simplify the function calls, bind away all arguments except the // cell range typedef - std_cxx1x::function &range)> + std_cxx11::function &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::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 &, + std_cxx11::function &, OutVector &, const InVector &, const std::pair &)> - function = std_cxx1x::bind(function_pointer, - std_cxx1x::cref(*owning_class), - std_cxx1x::_1, - std_cxx1x::_2, - std_cxx1x::_3, - std_cxx1x::_4); + function = std_cxx11::bind(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::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 &, + std_cxx11::function &, OutVector &, const InVector &, const std::pair &)> - function = std_cxx1x::bind(function_pointer, - std_cxx1x::ref(*owning_class), - std_cxx1x::_1, - std_cxx1x::_2, - std_cxx1x::_3, - std_cxx1x::_4); + function = std_cxx11::bind(function_pointer, + std_cxx11::ref(*owning_class), + std_cxx11::_1, + std_cxx11::_2, + std_cxx11::_3, + std_cxx11::_4); cell_loop (function, dst, src); } diff --git a/include/deal.II/meshworker/dof_info.h b/include/deal.II/meshworker/dof_info.h index 83b43b83df..b345de0806 100644 --- a/include/deal.II/meshworker/dof_info.h +++ b/include/deal.II/meshworker/dof_info.h @@ -20,7 +20,7 @@ #include #include -#include +#include #include #include #include diff --git a/include/deal.II/meshworker/integration_info.h b/include/deal.II/meshworker/integration_info.h index f28b162dfb..00178b2526 100644 --- a/include/deal.II/meshworker/integration_info.h +++ b/include/deal.II/meshworker/integration_info.h @@ -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 #include -#include +#include #include #include #include @@ -79,7 +79,7 @@ namespace MeshWorker { private: /// vector of FEValues objects - std::vector > > fevalv; + std::vector > > 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 > &data); + void initialize_data(const std_cxx11::shared_ptr > &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 > global_data; + std_cxx11::shared_ptr > global_data; /** * The memory used by this object. @@ -490,9 +490,9 @@ namespace MeshWorker */ MeshWorker::VectorSelector face_selector; - std_cxx1x::shared_ptr > cell_data; - std_cxx1x::shared_ptr > boundary_data; - std_cxx1x::shared_ptr > face_data; + std_cxx11::shared_ptr > cell_data; + std_cxx11::shared_ptr > boundary_data; + std_cxx11::shared_ptr > face_data; /* @} */ /** @@ -575,7 +575,7 @@ namespace MeshWorker : fevalv(0), multigrid(false), - global_data(std_cxx1x::shared_ptr >(new VectorDataBase)) + global_data(std_cxx11::shared_ptr >(new VectorDataBase)) {} @@ -600,14 +600,14 @@ namespace MeshWorker const FESubfaceValues *ps = dynamic_cast*>(&p); if (pc != 0) - fevalv[i] = std_cxx1x::shared_ptr > ( + fevalv[i] = std_cxx11::shared_ptr > ( new FEValues (pc->get_mapping(), pc->get_fe(), pc->get_quadrature(), pc->get_update_flags())); else if (pf != 0) - fevalv[i] = std_cxx1x::shared_ptr > ( + fevalv[i] = std_cxx11::shared_ptr > ( new FEFaceValues (pf->get_mapping(), pf->get_fe(), pf->get_quadrature(), pf->get_update_flags())); else if (ps != 0) - fevalv[i] = std_cxx1x::shared_ptr > ( + fevalv[i] = std_cxx11::shared_ptr > ( new FESubfaceValues (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 > ( + fevalv[0] = std_cxx11::shared_ptr > ( 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[i] = std_cxx11::shared_ptr > ( 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 > p; + std_cxx11::shared_ptr > p; VectorDataBase *pp; - p = std_cxx1x::shared_ptr >(new VectorData (cell_selector)); + p = std_cxx11::shared_ptr >(new VectorData (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 >(new VectorData (boundary_selector)); + p = std_cxx11::shared_ptr >(new VectorData (boundary_selector)); pp = &*p; pp->initialize(data); boundary_data = p; boundary.initialize_data(p); - p = std_cxx1x::shared_ptr >(new VectorData (face_selector)); + p = std_cxx11::shared_ptr >(new VectorData (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 > p; + std_cxx11::shared_ptr > p; - p = std_cxx1x::shared_ptr >(new VectorData (cell_selector)); + p = std_cxx11::shared_ptr >(new VectorData (cell_selector)); p->initialize(data); cell_data = p; cell.initialize_data(p); - p = std_cxx1x::shared_ptr >(new VectorData (boundary_selector)); + p = std_cxx11::shared_ptr >(new VectorData (boundary_selector)); p->initialize(data); boundary_data = p; boundary.initialize_data(p); - p = std_cxx1x::shared_ptr >(new VectorData (face_selector)); + p = std_cxx11::shared_ptr >(new VectorData (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 > p; + std_cxx11::shared_ptr > p; - p = std_cxx1x::shared_ptr >(new MGVectorData (cell_selector)); + p = std_cxx11::shared_ptr >(new MGVectorData (cell_selector)); p->initialize(data); cell_data = p; cell.initialize_data(p); - p = std_cxx1x::shared_ptr >(new MGVectorData (boundary_selector)); + p = std_cxx11::shared_ptr >(new MGVectorData (boundary_selector)); p->initialize(data); boundary_data = p; boundary.initialize_data(p); - p = std_cxx1x::shared_ptr >(new MGVectorData (face_selector)); + p = std_cxx11::shared_ptr >(new MGVectorData (face_selector)); p->initialize(data); face_data = p; face.initialize_data(p); diff --git a/include/deal.II/meshworker/integration_info.templates.h b/include/deal.II/meshworker/integration_info.templates.h index b1e1c21932..3acaa15299 100644 --- a/include/deal.II/meshworker/integration_info.templates.h +++ b/include/deal.II/meshworker/integration_info.templates.h @@ -26,7 +26,7 @@ namespace MeshWorker template void IntegrationInfo::initialize_data( - const std_cxx1x::shared_ptr > &data) + const std_cxx11::shared_ptr > &data) { global_data = data; const unsigned int nqp = fevalv[0]->n_quadrature_points; diff --git a/include/deal.II/meshworker/local_integrator.h b/include/deal.II/meshworker/local_integrator.h index b59cba7d2e..df17280466 100644 --- a/include/deal.II/meshworker/local_integrator.h +++ b/include/deal.II/meshworker/local_integrator.h @@ -20,7 +20,7 @@ #include #include -#include +#include #include #include diff --git a/include/deal.II/meshworker/local_results.h b/include/deal.II/meshworker/local_results.h index 828632548a..036d7c7073 100644 --- a/include/deal.II/meshworker/local_results.h +++ b/include/deal.II/meshworker/local_results.h @@ -19,7 +19,7 @@ #define __deal2__mesh_worker_local_results_h #include -#include +#include #include #include #include diff --git a/include/deal.II/meshworker/loop.h b/include/deal.II/meshworker/loop.h index 0bc20f0cd2..5e28d04e37 100644 --- a/include/deal.II/meshworker/loop.h +++ b/include/deal.II/meshworker/loop.h @@ -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 -#include +#include #include #include #include @@ -167,9 +167,9 @@ namespace MeshWorker ITERATOR cell, DoFInfoBox &dof_info, INFOBOX &info, - const std_cxx1x::function &cell_worker, - const std_cxx1x::function &boundary_worker, - const std_cxx1x::function &cell_worker, + const std_cxx11::function &boundary_worker, + const std_cxx11::function &face_worker, const LoopControl &loop_control) @@ -377,9 +377,9 @@ namespace MeshWorker typename identity::type end, DOFINFO &dinfo, INFOBOX &info, - const std_cxx1x::function &cell_worker, - const std_cxx1x::function &boundary_worker, - const std_cxx1x::function &cell_worker, + const std_cxx11::function &boundary_worker, + const std_cxx11::function &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, - std_cxx1x::_1, std_cxx1x::_3, std_cxx1x::_2, + std_cxx11::bind(&cell_action, + std_cxx11::_1, std_cxx11::_3, std_cxx11::_2, cell_worker, boundary_worker, face_worker, lctrl), - std_cxx1x::bind(&internal::assemble, std_cxx1x::_1, &assembler), + std_cxx11::bind(&internal::assemble, std_cxx11::_1, &assembler), info, dof_info); #else for (ITERATOR cell = begin; cell != end; ++cell) @@ -419,9 +419,9 @@ namespace MeshWorker typename identity::type end, DOFINFO &dinfo, INFOBOX &info, - const std_cxx1x::function &cell_worker, - const std_cxx1x::function &boundary_worker, - const std_cxx1x::function &cell_worker, + const std_cxx11::function &boundary_worker, + const std_cxx11::function &face_worker, ASSEMBLER &assembler, @@ -433,9 +433,9 @@ namespace MeshWorker typename identity::type end, DOFINFO &dinfo, INFOBOX &info, - const std_cxx1x::function &cell_worker, - const std_cxx1x::function &boundary_worker, - const std_cxx1x::function &cell_worker, + const std_cxx11::function &boundary_worker, + const std_cxx11::function &face_worker, ASSEMBLER &assembler, @@ -465,9 +465,9 @@ namespace MeshWorker typename identity::type end, DoFInfo &dof_info, IntegrationInfoBox &box, - const std_cxx1x::function&, IntegrationInfo&)> &cell_worker, - const std_cxx1x::function&, IntegrationInfo&)> &boundary_worker, - const std_cxx1x::function &, DoFInfo &, + const std_cxx11::function&, IntegrationInfo&)> &cell_worker, + const std_cxx11::function&, IntegrationInfo&)> &boundary_worker, + const std_cxx11::function &, DoFInfo &, IntegrationInfo &, IntegrationInfo &)> &face_worker, ASSEMBLER &assembler, @@ -479,9 +479,9 @@ namespace MeshWorker typename identity::type end, DoFInfo &dof_info, IntegrationInfoBox &box, - const std_cxx1x::function&, IntegrationInfo&)> &cell_worker, - const std_cxx1x::function&, IntegrationInfo&)> &boundary_worker, - const std_cxx1x::function &, DoFInfo &, + const std_cxx11::function&, IntegrationInfo&)> &cell_worker, + const std_cxx11::function&, IntegrationInfo&)> &boundary_worker, + const std_cxx11::function &, DoFInfo &, IntegrationInfo &, IntegrationInfo &)> &face_worker, ASSEMBLER &assembler, @@ -528,17 +528,17 @@ namespace MeshWorker ASSEMBLER &assembler, bool cells_first) { - std_cxx1x::function&, IntegrationInfo&)> cell_worker; - std_cxx1x::function&, IntegrationInfo&)> boundary_worker; - std_cxx1x::function &, DoFInfo &, + std_cxx11::function&, IntegrationInfo&)> cell_worker; + std_cxx11::function&, IntegrationInfo&)> boundary_worker; + std_cxx11::function &, DoFInfo &, IntegrationInfo &, IntegrationInfo &)> face_worker; if (integrator.use_cell) - cell_worker = std_cxx1x::bind(&LocalIntegrator::cell, &integrator, std_cxx1x::_1, std_cxx1x::_2); + cell_worker = std_cxx11::bind(&LocalIntegrator::cell, &integrator, std_cxx11::_1, std_cxx11::_2); if (integrator.use_boundary) - boundary_worker = std_cxx1x::bind(&LocalIntegrator::boundary, &integrator, std_cxx1x::_1, std_cxx1x::_2); + boundary_worker = std_cxx11::bind(&LocalIntegrator::boundary, &integrator, std_cxx11::_1, std_cxx11::_2); if (integrator.use_face) - face_worker = std_cxx1x::bind(&LocalIntegrator::face, &integrator, std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::_4); + face_worker = std_cxx11::bind(&LocalIntegrator::face, &integrator, std_cxx11::_1, std_cxx11::_2, std_cxx11::_3, std_cxx11::_4); loop (begin, end, @@ -563,17 +563,17 @@ namespace MeshWorker ASSEMBLER &assembler, const LoopControl &lctrl = LoopControl()) { - std_cxx1x::function&, IntegrationInfo&)> cell_worker; - std_cxx1x::function&, IntegrationInfo&)> boundary_worker; - std_cxx1x::function &, DoFInfo &, + std_cxx11::function&, IntegrationInfo&)> cell_worker; + std_cxx11::function&, IntegrationInfo&)> boundary_worker; + std_cxx11::function &, DoFInfo &, IntegrationInfo &, IntegrationInfo &)> face_worker; if (integrator.use_cell) - cell_worker = std_cxx1x::bind(&LocalIntegrator::cell, &integrator, std_cxx1x::_1, std_cxx1x::_2); + cell_worker = std_cxx11::bind(&LocalIntegrator::cell, &integrator, std_cxx11::_1, std_cxx11::_2); if (integrator.use_boundary) - boundary_worker = std_cxx1x::bind(&LocalIntegrator::boundary, &integrator, std_cxx1x::_1, std_cxx1x::_2); + boundary_worker = std_cxx11::bind(&LocalIntegrator::boundary, &integrator, std_cxx11::_1, std_cxx11::_2); if (integrator.use_face) - face_worker = std_cxx1x::bind(&LocalIntegrator::face, &integrator, std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::_4); + face_worker = std_cxx11::bind(&LocalIntegrator::face, &integrator, std_cxx11::_1, std_cxx11::_2, std_cxx11::_3, std_cxx11::_4); loop (begin, end, diff --git a/include/deal.II/multigrid/mg_matrix.h b/include/deal.II/multigrid/mg_matrix.h index ca7d17925c..f99fa086f0 100644 --- a/include/deal.II/multigrid/mg_matrix.h +++ b/include/deal.II/multigrid/mg_matrix.h @@ -22,7 +22,7 @@ #include #include #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -83,7 +83,7 @@ namespace mg */ std::size_t memory_consumption () const; private: - MGLevelObject > > matrices; + MGLevelObject > > 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 > (new_pointer_matrix_base(p[level], VECTOR())); + matrices[level] = std_cxx11::shared_ptr > (new_pointer_matrix_base(p[level], VECTOR())); } diff --git a/include/deal.II/multigrid/mg_transfer.h b/include/deal.II/multigrid/mg_transfer.h index 272f527403..c80432defd 100644 --- a/include/deal.II/multigrid/mg_transfer.h +++ b/include/deal.II/multigrid/mg_transfer.h @@ -33,7 +33,7 @@ #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -269,14 +269,14 @@ private: /** * Sparsity patterns for transfer matrices. */ - std::vector::Sparsity> > prolongation_sparsities; + std::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::Matrix> > prolongation_matrices; + std::vector::Matrix> > prolongation_matrices; /** * Mapping for the copy_to_mg() and copy_from_mg() functions. Here only diff --git a/include/deal.II/multigrid/mg_transfer_block.h b/include/deal.II/multigrid/mg_transfer_block.h index b06e47f404..7623b1c08f 100644 --- a/include/deal.II/multigrid/mg_transfer_block.h +++ b/include/deal.II/multigrid/mg_transfer_block.h @@ -33,7 +33,7 @@ #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -148,7 +148,7 @@ protected: DeclException0(ExcMatricesNotBuilt); private: - std::vector > prolongation_sparsities; + std::vector > prolongation_sparsities; protected: @@ -160,7 +160,7 @@ protected: * while row indices belong to the * child cell, i.e. the fine level. */ - std::vector > > prolongation_matrices; + std::vector > > prolongation_matrices; /** * Mapping for the diff --git a/include/deal.II/multigrid/mg_transfer_component.h b/include/deal.II/multigrid/mg_transfer_component.h index 305c828532..518f196f95 100644 --- a/include/deal.II/multigrid/mg_transfer_component.h +++ b/include/deal.II/multigrid/mg_transfer_component.h @@ -19,7 +19,7 @@ #include -#include +#include #include #include #include @@ -147,7 +147,7 @@ protected: DeclException0(ExcMatricesNotBuilt); private: - std::vector > prolongation_sparsities; + std::vector > prolongation_sparsities; protected: @@ -159,7 +159,7 @@ protected: * while row indices belong to the * child cell, i.e. the fine level. */ - std::vector > > prolongation_matrices; + std::vector > > prolongation_matrices; /** * Holds the mapping for the diff --git a/include/deal.II/multigrid/sparse_matrix_collection.h b/include/deal.II/multigrid/sparse_matrix_collection.h index 5e128a2f39..fca0ad3e2a 100644 --- a/include/deal.II/multigrid/sparse_matrix_collection.h +++ b/include/deal.II/multigrid/sparse_matrix_collection.h @@ -24,7 +24,7 @@ #include #include #include -#include +#include DEAL_II_NAMESPACE_OPEN diff --git a/include/deal.II/numerics/data_out.h b/include/deal.II/numerics/data_out.h index adba6b9e95..a4bb73387a 100644 --- a/include/deal.II/numerics/data_out.h +++ b/include/deal.II/numerics/data_out.h @@ -22,7 +22,7 @@ #include #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -44,7 +44,7 @@ namespace internal const unsigned int n_subdivisions, const std::vector &n_postprocessor_outputs, const Mapping &mapping, - const std::vector > > &finite_elements, + const std::vector > > &finite_elements, const UpdateFlags update_flags, const std::vector > &cell_to_patch_index_map); diff --git a/include/deal.II/numerics/data_out_dof_data.h b/include/deal.II/numerics/data_out_dof_data.h index fdc24dbd2f..25cf4f2e28 100644 --- a/include/deal.II/numerics/data_out_dof_data.h +++ b/include/deal.II/numerics/data_out_dof_data.h @@ -32,7 +32,7 @@ #include #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -214,14 +214,14 @@ namespace internal const unsigned int n_subdivisions, const std::vector &n_postprocessor_outputs, const Mapping &mapping, - const std::vector > > &finite_elements, + const std::vector > > &finite_elements, const UpdateFlags update_flags, const bool use_face_values); ParallelDataBase (const ParallelDataBase &data); template - void reinit_all_fe_values(std::vector > > &dof_data, + void reinit_all_fe_values(std::vector > > &dof_data, const typename dealii::Triangulation::cell_iterator &cell, const unsigned int face = numbers::invalid_unsigned_int); @@ -242,11 +242,11 @@ namespace internal std::vector > > postprocessed_values; const dealii::hp::MappingCollection mapping_collection; - const std::vector > > finite_elements; + const std::vector > > finite_elements; const UpdateFlags update_flags; - std::vector > > x_fe_values; - std::vector > > x_fe_face_values; + std::vector > > x_fe_values; + std::vector > > x_fe_face_values; }; } } @@ -785,12 +785,12 @@ protected: /** * List of data elements with vectors of values for each degree of freedom. */ - std::vector > > dof_data; + std::vector > > dof_data; /** * List of data elements with vectors of values for each cell. */ - std::vector > > cell_data; + std::vector > > 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(0) in case only the triangulation is used. */ - std::vector > > + std::vector > > get_finite_elements() const; /** @@ -825,7 +825,7 @@ protected: * function. See there for a more extensive documentation. */ virtual - std::vector > + std::vector > get_vector_data_ranges () const; /** @@ -874,16 +874,16 @@ merge_patches (const DataOut_DoFData &source, "as vectors.")); for (unsigned int i=0; i(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.")); } diff --git a/include/deal.II/numerics/data_out_faces.h b/include/deal.II/numerics/data_out_faces.h index 08d65d1927..21ff8b6e01 100644 --- a/include/deal.II/numerics/data_out_faces.h +++ b/include/deal.II/numerics/data_out_faces.h @@ -47,7 +47,7 @@ namespace internal const unsigned int n_subdivisions, const std::vector &n_postprocessor_outputs, const Mapping &mapping, - const std::vector > > &finite_elements, + const std::vector > > &finite_elements, const UpdateFlags update_flags); std::vector > patch_normals; diff --git a/include/deal.II/numerics/data_out_rotation.h b/include/deal.II/numerics/data_out_rotation.h index 0099d6d877..9152953927 100644 --- a/include/deal.II/numerics/data_out_rotation.h +++ b/include/deal.II/numerics/data_out_rotation.h @@ -48,7 +48,7 @@ namespace internal const unsigned int n_patches_per_circle, const std::vector &n_postprocessor_outputs, const Mapping &mapping, - const std::vector > > &finite_elements, + const std::vector > > &finite_elements, const UpdateFlags update_flags); const unsigned int n_patches_per_circle; diff --git a/include/deal.II/numerics/derivative_approximation.h b/include/deal.II/numerics/derivative_approximation.h index 4cff0bef05..e1e9f00a65 100644 --- a/include/deal.II/numerics/derivative_approximation.h +++ b/include/deal.II/numerics/derivative_approximation.h @@ -19,7 +19,7 @@ #include #include -#include +#include #include #include #include diff --git a/include/deal.II/numerics/vector_tools.templates.h b/include/deal.II/numerics/vector_tools.templates.h index efa2c2d922..3f732b26f6 100644 --- a/include/deal.II/numerics/vector_tools.templates.h +++ b/include/deal.II/numerics/vector_tools.templates.h @@ -60,7 +60,7 @@ #include #include -#include +#include #include #include #include @@ -4870,8 +4870,8 @@ namespace VectorTools template struct PointComparator { - bool operator ()(const std_cxx1x::array &p1, - const std_cxx1x::array &p2) + bool operator ()(const std_cxx11::array &p1, + const std_cxx11::array &p2) { for (unsigned int d=0; d, PointComparator > vector_dofs; + std::set, PointComparator > vector_dofs; std::vector face_dofs; - std::map, Vector > + std::map, Vector > dof_vector_to_b_values; std::set::iterator b_id; - std::vector > cell_vector_dofs; + std::vector > cell_vector_dofs; for (typename DH::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, + for (typename std::set, PointComparator >::const_iterator it=vector_dofs.begin(); it!=vector_dofs.end(); ++it) { diff --git a/source/base/data_out_base.cc b/source/base/data_out_base.cc index ccbc597a23..2a9cd045be 100644 --- a/source/base/data_out_base.cc +++ b/source/base/data_out_base.cc @@ -37,7 +37,7 @@ #include #include #include -#include +#include #include #include @@ -2950,7 +2950,7 @@ namespace DataOutBase template void write_ucd (const std::vector > &patches, const std::vector &data_names, - const std::vector > &, + const std::vector > &, const UcdFlags &flags, std::ostream &out) { @@ -3049,7 +3049,7 @@ namespace DataOutBase template void write_dx (const std::vector > &patches, const std::vector &data_names, - const std::vector > &, + const std::vector > &, const DXFlags &flags, std::ostream &out) { @@ -3347,7 +3347,7 @@ namespace DataOutBase template void write_gnuplot (const std::vector > &patches, const std::vector &data_names, - const std::vector > &, + const std::vector > &, const GnuplotFlags &/*flags*/, std::ostream &out) { @@ -3582,7 +3582,7 @@ namespace DataOutBase template void write_povray (const std::vector > &patches, const std::vector &data_names, - const std::vector > &, + const std::vector > &, const PovrayFlags &flags, std::ostream &out) { @@ -3949,7 +3949,7 @@ namespace DataOutBase template void write_eps (const std::vector > &patches, const std::vector &/*data_names*/, - const std::vector > &, + const std::vector > &, const EpsFlags &flags, std::ostream &out) { @@ -3961,7 +3961,7 @@ namespace DataOutBase template void write_eps (const std::vector > &patches, const std::vector &/*data_names*/, - const std::vector > &, + const std::vector > &, const EpsFlags &flags, std::ostream &out) { @@ -4339,7 +4339,7 @@ namespace DataOutBase template void write_gmv (const std::vector > &patches, const std::vector &data_names, - const std::vector > &, + const std::vector > &, const GmvFlags &flags, std::ostream &out) { @@ -4494,7 +4494,7 @@ namespace DataOutBase template void write_tecplot (const std::vector > &patches, const std::vector &data_names, - const std::vector > &, + const std::vector > &, const TecplotFlags &flags, std::ostream &out) { @@ -4742,7 +4742,7 @@ namespace DataOutBase template void write_tecplot_binary (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const TecplotFlags &flags, std::ostream &out) { @@ -5088,7 +5088,7 @@ namespace DataOutBase void write_vtk (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const VtkFlags &flags, std::ostream &out) { @@ -5260,21 +5260,21 @@ namespace DataOutBase std::vector data_set_written (n_data_sets, false); for (unsigned int n_th_vector=0; n_th_vector(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(vector_data_ranges[n_th_vector]); + for (unsigned int i=std_cxx11::get<0>(vector_data_ranges[n_th_vector]); + i(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(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 > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const VtkFlags &flags, std::ostream &out) { @@ -5425,7 +5425,7 @@ namespace DataOutBase template void write_vtu_main (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &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 << " (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(vector_data_ranges[n_th_vector]); + for (unsigned int i=std_cxx11::get<0>(vector_data_ranges[n_th_vector]); + i(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\">\n"; @@ -5680,22 +5680,22 @@ namespace DataOutBase std::vector data_set_written (n_data_sets, false); for (unsigned int n_th_vector=0; n_th_vector(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 << " (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(vector_data_ranges[n_th_vector]); + for (unsigned int i=std_cxx11::get<0>(vector_data_ranges[n_th_vector]); + i(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(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 void write_svg (const std::vector > &, const std::vector &, - const std::vector > &, + const std::vector > &, const SvgFlags &, std::ostream &) { @@ -5804,7 +5804,7 @@ namespace DataOutBase template void write_svg (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const SvgFlags &flags, std::ostream &out) { @@ -6446,7 +6446,7 @@ namespace DataOutBase void write_deal_II_intermediate (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &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[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::write_pvtu_record (std::ostream &out, AssertThrow (out, ExcIO()); const std::vector data_names = get_dataset_names(); - const std::vector > vector_data_ranges + const std::vector > vector_data_ranges = get_vector_data_ranges(); const unsigned int n_data_sets = data_names.size(); @@ -6760,22 +6760,22 @@ DataOutInterface::write_pvtu_record (std::ostream &out, std::vector data_set_written (n_data_sets, false); for (unsigned int n_th_vector=0; n_th_vector(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::write_pvtu_record (std::ostream &out, // name has been specified out << " (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(vector_data_ranges[n_th_vector]); + for (unsigned int i=std_cxx11::get<0>(vector_data_ranges[n_th_vector]); + i(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 void DataOutBase::write_filtered_data (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &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 > & for (n_th_vector=0,data_set=0; data_set(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(vector_data_ranges[n_th_vector]); ++i) + for (i=std_cxx11::get<0>(vector_data_ranges[n_th_vector]); i(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::memory_consumption () const template -std::vector > +std::vector > DataOutInterface::get_vector_data_ranges () const { - return std::vector >(); + return std::vector >(); } @@ -7795,7 +7795,7 @@ DataOutReader::read (std::istream &in) tmp.swap (dataset_names); } { - std::vector > tmp; + std::vector > tmp; tmp.swap (vector_data_ranges); } @@ -7870,8 +7870,8 @@ DataOutReader::read (std::istream &in) vector_data_ranges.resize (n_vector_data_ranges); for (unsigned int i=0; i> 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::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 &source) "as vectors.")); for (unsigned int i=0; i(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::get_dataset_names () const template -std::vector > +std::vector > DataOutReader::get_vector_data_ranges () const { return vector_data_ranges; diff --git a/source/base/data_out_base.inst.in b/source/base/data_out_base.inst.in index dc4ea59823..b1f0567c6b 100644 --- a/source/base/data_out_base.inst.in +++ b/source/base/data_out_base.inst.in @@ -39,7 +39,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS void write_vtk (const std::vector > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &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 > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &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 > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &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 > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &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 > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &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 > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &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 > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &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 > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &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 > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &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 > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &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 > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &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 > &patches, const std::vector &data_names, - const std::vector > &vector_data_ranges, + const std::vector > &vector_data_ranges, const Deal_II_IntermediateFlags &flags, std::ostream &out); \} diff --git a/source/base/function.cc b/source/base/function.cc index 7850cc6eb7..7e3e33cecf 100644 --- a/source/base/function.cc +++ b/source/base/function.cc @@ -521,7 +521,7 @@ ComponentSelectFunction::memory_consumption () const template ScalarFunctionFromFunctionObject:: -ScalarFunctionFromFunctionObject (const std_cxx1x::function &)> &function_object) +ScalarFunctionFromFunctionObject (const std_cxx11::function &)> &function_object) : Function(1), function_object (function_object) @@ -543,7 +543,7 @@ ScalarFunctionFromFunctionObject::value (const Point & template VectorFunctionFromScalarFunctionObject:: -VectorFunctionFromScalarFunctionObject (const std_cxx1x::function &)> &function_object, +VectorFunctionFromScalarFunctionObject (const std_cxx11::function &)> &function_object, const unsigned int selected_component, const unsigned int n_components) : diff --git a/source/base/function_lib.cc b/source/base/function_lib.cc index 46c1c5d95a..c4d9c119e1 100644 --- a/source/base/function_lib.cc +++ b/source/base/function_lib.cc @@ -2318,7 +2318,7 @@ namespace Functions template InterpolatedTensorProductGridData:: - InterpolatedTensorProductGridData(const std_cxx1x::array,dim> &coordinate_values, + InterpolatedTensorProductGridData(const std_cxx11::array,dim> &coordinate_values, const Table &data_values) : coordinate_values (coordinate_values), @@ -2389,8 +2389,8 @@ namespace Functions template InterpolatedUniformGridData:: - InterpolatedUniformGridData(const std_cxx1x::array,dim> &interval_endpoints, - const std_cxx1x::array &n_subintervals, + InterpolatedUniformGridData(const std_cxx11::array,dim> &interval_endpoints, + const std_cxx11::array &n_subintervals, const Table &data_values) : interval_endpoints (interval_endpoints), diff --git a/source/base/parameter_handler.cc b/source/base/parameter_handler.cc index f8e14067a1..7c2e5b2c6f 100644 --- a/source/base/parameter_handler.cc +++ b/source/base/parameter_handler.cc @@ -548,7 +548,7 @@ namespace Patterns std::string str; std::getline(is, str, '>'); - std_cxx1x::shared_ptr base_pattern (pattern_factory(str)); + std_cxx11::shared_ptr 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 key_pattern (pattern_factory(key)); - std_cxx1x::shared_ptr value_pattern (pattern_factory(value)); + std_cxx11::shared_ptr key_pattern (pattern_factory(key)); + std_cxx11::shared_ptr 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 ¤t_path, const char path_separator, - const std::vector > & + const std::vector > & 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 + patterns.push_back (std_cxx11::shared_ptr (pattern.clone())); entries->put (get_current_full_path(entry) + path_separator + "pattern", static_cast(patterns.size()-1)); diff --git a/source/base/polynomial.cc b/source/base/polynomial.cc index f6fa8b2f3c..4f459c7580 100644 --- a/source/base/polynomial.cc +++ b/source/base/polynomial.cc @@ -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 > q_data; + std_cxx11::shared_ptr > q_data; const Polynomial *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 > q_data; + std_cxx11::shared_ptr > q_data; const Polynomial *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 > q_data; + std_cxx11::shared_ptr > q_data; const Polynomial *q = 0; if (p.in_lagrange_product_form == true) { @@ -587,7 +587,7 @@ namespace Polynomials if (degree() == 0) return Monomial(0, 0.); - std_cxx1x::shared_ptr > q_data; + std_cxx11::shared_ptr > q_data; const Polynomial *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 > q_data; + std_cxx11::shared_ptr > q_data; const Polynomial *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::vector > > Legendre::recursive_coefficients(20); - std::vector > > + std::vector > > 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 >()))) + std_cxx11::shared_ptr >()))) // 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 >(c0); + std_cxx11::shared_ptr >(c0); recursive_coefficients[1] = - std_cxx1x::shared_ptr >(c1); + std_cxx11::shared_ptr >(c1); // Compute polynomials // orthogonal on [0,1] @@ -939,8 +939,8 @@ namespace Polynomials Polynomial::shift (*c1, -1.); Polynomial::scale(*c1, 2.); Polynomial::multiply(*c1, std::sqrt(3.)); - shifted_coefficients[0]=std_cxx1x::shared_ptr >(c0); - shifted_coefficients[1]=std_cxx1x::shared_ptr >(c1); + shifted_coefficients[0]=std_cxx11::shared_ptr >(c0); + shifted_coefficients[1]=std_cxx11::shared_ptr >(c1); } else { @@ -975,7 +975,7 @@ namespace Polynomials // const pointer in the // coefficients array recursive_coefficients[k] = - std_cxx1x::shared_ptr >(ck); + std_cxx11::shared_ptr >(ck); // and compute the // coefficients for [0,1] ck = new std::vector(*ck); @@ -983,7 +983,7 @@ namespace Polynomials Polynomial::scale(*ck, 2.); Polynomial::multiply(*ck, std::sqrt(2.*k+1.)); shifted_coefficients[k] = - std_cxx1x::shared_ptr >(ck); + std_cxx11::shared_ptr >(ck); }; }; } @@ -1110,7 +1110,7 @@ namespace Polynomials // Reserve space for polynomials up to degree 19. Should be sufficient // for the start. - std::vector > > + std::vector > > Hierarchical::recursive_coefficients(20); @@ -1187,9 +1187,9 @@ namespace Polynomials // now make these arrays // const recursive_coefficients[0] = - std_cxx1x::shared_ptr >(c0); + std_cxx11::shared_ptr >(c0); recursive_coefficients[1] = - std_cxx1x::shared_ptr >(c1); + std_cxx11::shared_ptr >(c1); } else if (k==2) { @@ -1206,7 +1206,7 @@ namespace Polynomials (*c2)[2] = 4.*a; recursive_coefficients[2] = - std_cxx1x::shared_ptr >(c2); + std_cxx11::shared_ptr >(c2); } else { @@ -1250,7 +1250,7 @@ namespace Polynomials // const pointer in the // coefficients array recursive_coefficients[k] = - std_cxx1x::shared_ptr >(ck); + std_cxx11::shared_ptr >(ck); }; }; } diff --git a/source/distributed/solution_transfer.cc b/source/distributed/solution_transfer.cc index f5aced6a3e..a979e37b20 100644 --- a/source/distributed/solution_transfer.cc +++ b/source/distributed/solution_transfer.cc @@ -35,7 +35,7 @@ #include #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -85,11 +85,11 @@ namespace parallel offset = tria->register_data_attach(size, - std_cxx1x::bind(&SolutionTransfer::pack_callback, + std_cxx11::bind(&SolutionTransfer::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::unpack_callback, + std_cxx11::bind(&SolutionTransfer::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::iterator it=all_out.begin(); diff --git a/source/distributed/tria.cc b/source/distributed/tria.cc index e25b5a8a93..fe4cd363f9 100644 --- a/source/distributed/tria.cc +++ b/source/distributed/tria.cc @@ -1369,13 +1369,13 @@ namespace attach_mesh_data_recursively (const typename internal::p4est::types::tree &tree, const typename Triangulation::cell_iterator &dealii_cell, const typename internal::p4est::types::quadrant &p4est_cell, - const typename std::list::cell_iterator, typename parallel::distributed::Triangulation::CellStatus, void *) > > > &attached_data_pack_callbacks) { - typedef std::list::cell_iterator, typename parallel::distributed::Triangulation::CellStatus, void *) @@ -1530,7 +1530,7 @@ namespace const typename Triangulation::cell_iterator &parent_cell, const typename internal::p4est::types::quadrant &p4est_cell, const unsigned int offset, - const typename std_cxx1x::function< + const typename std_cxx11::function< void(typename parallel::distributed::Triangulation::cell_iterator, typename parallel::distributed::Triangulation::CellStatus, void *) > &unpack_callback) { @@ -3233,7 +3233,7 @@ namespace parallel unsigned int Triangulation:: register_data_attach (const std::size_t size, - const std_cxx1x::function &pack_callback) { @@ -3256,7 +3256,7 @@ namespace parallel void Triangulation:: notify_ready_to_unpack (const unsigned int offset, - const std_cxx1x::function &unpack_callback) { diff --git a/source/dofs/dof_tools_constraints.cc b/source/dofs/dof_tools_constraints.cc index 78574d8848..21f2c9723a 100644 --- a/source/dofs/dof_tools_constraints.cc +++ b/source/dofs/dof_tools_constraints.cc @@ -306,11 +306,11 @@ namespace DoFTools ensure_existence_of_master_dof_mask (const FiniteElement &fe1, const FiniteElement &fe2, const FullMatrix &face_interpolation_matrix, - std_cxx1x::shared_ptr > &master_dof_mask) + std_cxx11::shared_ptr > &master_dof_mask) { - if (master_dof_mask == std_cxx1x::shared_ptr >()) + if (master_dof_mask == std_cxx11::shared_ptr >()) { - master_dof_mask = std_cxx1x::shared_ptr > + master_dof_mask = std_cxx11::shared_ptr > (new std::vector (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 &fe1, const FiniteElement &fe2, - std_cxx1x::shared_ptr > &matrix) + std_cxx11::shared_ptr > &matrix) { - if (matrix == std_cxx1x::shared_ptr >()) + if (matrix == std_cxx11::shared_ptr >()) { - matrix = std_cxx1x::shared_ptr > + matrix = std_cxx11::shared_ptr > (new FullMatrix (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 &fe1, const FiniteElement &fe2, const unsigned int subface, - std_cxx1x::shared_ptr > &matrix) + std_cxx11::shared_ptr > &matrix) { - if (matrix == std_cxx1x::shared_ptr >()) + if (matrix == std_cxx11::shared_ptr >()) { - matrix = std_cxx1x::shared_ptr > + matrix = std_cxx11::shared_ptr > (new FullMatrix (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 &face_interpolation_matrix, const std::vector &master_dof_mask, - std_cxx1x::shared_ptr,FullMatrix > > &split_matrix) + std_cxx11::shared_ptr,FullMatrix > > &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,FullMatrix > >()) + std_cxx11::shared_ptr,FullMatrix > >()) { split_matrix - = std_cxx1x::shared_ptr,FullMatrix > > + = std_cxx11::shared_ptr,FullMatrix > > (new std::pair,FullMatrix >()); 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 > > + Table<2,std_cxx11::shared_ptr > > face_interpolation_matrices (n_finite_elements (dof_handler), n_finite_elements (dof_handler)); - Table<3,std_cxx1x::shared_ptr > > + Table<3,std_cxx11::shared_ptr > > subface_interpolation_matrices (n_finite_elements (dof_handler), n_finite_elements (dof_handler), GeometryInfo::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,FullMatrix > > > + Table<2,std_cxx11::shared_ptr,FullMatrix > > > 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 > > + Table<2,std_cxx11::shared_ptr > > 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, - std_cxx1x::_1, - std_cxx1x::_2, - std_cxx1x::_3, + std_cxx11::bind(&compute_intergrid_weights_3, + 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(©_intergrid_weights_3, - 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(©_intergrid_weights_3, + 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); } diff --git a/source/fe/fe_system.cc b/source/fe/fe_system.cc index f6af894545..ec357629d0 100644 --- a/source/fe/fe_system.cc +++ b/source/fe/fe_system.cc @@ -1852,7 +1852,7 @@ void FESystem::initialize (const std::vector0) { base_elements[ind] = - std::make_pair (std_cxx1x::shared_ptr > + std::make_pair (std_cxx11::shared_ptr > (fes[i]->clone()), multiplicities[i]); ++ind; diff --git a/source/fe/fe_tools.cc b/source/fe/fe_tools.cc index ddbb5a0571..ad53b74c38 100644 --- a/source/fe/fe_tools.cc +++ b/source/fe/fe_tools.cc @@ -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 #include -#include +#include #include @@ -116,9 +116,9 @@ namespace template void - fill_no_codim_fe_names (std::map > &result) + fill_no_codim_fe_names (std::map > &result) { - typedef std_cxx1x::shared_ptr FEFactoryPointer; + typedef std_cxx11::shared_ptr FEFactoryPointer; result["FE_Q_Hierarchical"] = FEFactoryPointer(new FETools::FEFactory >); @@ -151,9 +151,9 @@ namespace // nonzero codimension. template void - fill_codim_fe_names (std::map > &result) + fill_codim_fe_names (std::map > &result) { - typedef std_cxx1x::shared_ptr FEFactoryPointer; + typedef std_cxx11::shared_ptr FEFactoryPointer; result["FE_DGP"] = FEFactoryPointer(new FETools::FEFactory >); @@ -171,12 +171,12 @@ namespace // by the functions above. std::vector > > > + std_cxx11::shared_ptr > > > fill_default_map() { std::vector > > > + std_cxx11::shared_ptr > > > result(4); for (unsigned int d=0; d<4; ++d) @@ -228,7 +228,7 @@ namespace static std::vector > > > + std_cxx11::shared_ptr > > > 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 (factory); + std_cxx11::shared_ptr (factory); } @@ -1323,7 +1323,7 @@ namespace FETools FiniteElement * get_fe_from_name_ext (std::string &name, const std::map > + std_cxx11::shared_ptr > &fe_name_map) { // Extract the name of the diff --git a/source/fe/fe_tools_interpolate.cc b/source/fe/fe_tools_interpolate.cc index 13a0dace97..69cfdac3aa 100644 --- a/source/fe/fe_tools_interpolate.cc +++ b/source/fe/fe_tools_interpolate.cc @@ -40,7 +40,7 @@ #include #include -#include +#include #include @@ -117,7 +117,7 @@ namespace FETools // that memory is released again std::map *, std::map *, - std_cxx1x::shared_ptr > > > + std_cxx11::shared_ptr > > > interpolation_matrices; typename DH1::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 > + std_cxx11::shared_ptr > interpolation_matrix (new FullMatrix (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 *, - std_cxx1x::shared_ptr > > interpolation_matrices; + std_cxx11::shared_ptr > > 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 > + std_cxx11::shared_ptr > (new FullMatrix(dofs_per_cell1, dofs_per_cell1)); get_back_interpolation_matrix(dof1.get_fe(), fe2, *interpolation_matrices[&cell->get_fe()]); diff --git a/source/fe/fe_values.cc b/source/fe/fe_values.cc index bc11087217..3169217a6c 100644 --- a/source/fe/fe_values.cc +++ b/source/fe/fe_values.cc @@ -3255,8 +3255,8 @@ maybe_invalidate_previous_present_cell (const typename Triangulationget_triangulation().signals.any_change.connect - (std_cxx1x::bind (&FEValuesBase::invalidate_present_cell, - std_cxx1x::ref(static_cast&>(*this)))); + (std_cxx11::bind (&FEValuesBase::invalidate_present_cell, + std_cxx11::ref(static_cast&>(*this)))); } } else @@ -3266,8 +3266,8 @@ maybe_invalidate_previous_present_cell (const typename Triangulationget_triangulation().signals.post_refinement.connect - (std_cxx1x::bind (&FEValuesBase::invalidate_present_cell, - std_cxx1x::ref(static_cast&>(*this)))); + (std_cxx11::bind (&FEValuesBase::invalidate_present_cell, + std_cxx11::ref(static_cast&>(*this)))); } } diff --git a/source/grid/grid_out.cc b/source/grid/grid_out.cc index b54c79c338..451a7cd62a 100644 --- a/source/grid/grid_out.cc +++ b/source/grid/grid_out.cc @@ -2469,7 +2469,7 @@ void GridOut::write_vtk (const Triangulation &tria, // information, etc. DataOutBase::write_vtk (triangulation_to_patches(tria), std::vector(), - std::vector >(), + std::vector >(), vtk_flags, out); @@ -2490,7 +2490,7 @@ void GridOut::write_vtu (const Triangulation &tria, // information, etc. DataOutBase::write_vtu (triangulation_to_patches(tria), std::vector(), - std::vector >(), + std::vector >(), vtu_flags, out); diff --git a/source/grid/grid_reordering.cc b/source/grid/grid_reordering.cc index 1091387cc5..fd31540556 100644 --- a/source/grid/grid_reordering.cc +++ b/source/grid/grid_reordering.cc @@ -19,7 +19,7 @@ #include #include #include -#include +#include #include #include @@ -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; diff --git a/source/grid/grid_tools.cc b/source/grid/grid_tools.cc index 6689f8a56c..f4a7d39587 100644 --- a/source/grid/grid_tools.cc +++ b/source/grid/grid_tools.cc @@ -14,7 +14,7 @@ // // --------------------------------------------------------------------- -#include +#include #include #include #include @@ -2156,7 +2156,7 @@ next_cell: template<> struct OrientationLookupTable<1> { - typedef std_cxx1x::array::vertices_per_face> MATCH_T; + typedef std_cxx11::array::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::vertices_per_face> MATCH_T; + typedef std_cxx11::array::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::vertices_per_face> MATCH_T; + typedef std_cxx11::array::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::vertices_per_face> matching; std::set face2_vertices; diff --git a/source/grid/tria.cc b/source/grid/tria.cc index ca640d4ed7..dd79a43d84 100644 --- a/source/grid/tria.cc +++ b/source/grid/tria.cc @@ -18,7 +18,7 @@ #include #include #include -#include +#include #include #include @@ -40,7 +40,7 @@ #include #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -2074,7 +2074,7 @@ namespace internal // this file std::map, std::pair::quad_iterator, - std_cxx1x::array::lines_per_face> >, + std_cxx11::array::lines_per_face> >, QuadComparator> needed_quads; for (unsigned int cell=0; cell line_list[GeometryInfo::lines_per_cell], inverse_line_list[GeometryInfo::lines_per_cell]; unsigned int face_line_list[GeometryInfo::lines_per_face]; - std_cxx1x::array::lines_per_face> orientation; + std_cxx11::array::lines_per_face> orientation; for (unsigned int line=0; line::lines_per_cell; ++line) { @@ -2226,7 +2226,7 @@ namespace internal quad = triangulation.begin_raw_quad(); typename std::map, std::pair::quad_iterator, - std_cxx1x::array::lines_per_face> >, + std_cxx11::array::lines_per_face> >, QuadComparator> ::iterator q; for (q = needed_quads.begin(); quad!=triangulation.end_quad(); ++quad, ++q) @@ -13273,22 +13273,22 @@ Triangulation::add_refinement_listener (RefinementListener &liste std::vector 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)); diff --git a/source/grid/tria_boundary.cc b/source/grid/tria_boundary.cc index 7024425f42..23f7998da2 100644 --- a/source/grid/tria_boundary.cc +++ b/source/grid/tria_boundary.cc @@ -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 > + std_cxx11::shared_ptr > quadrature (new QGaussLobatto<1>(n_intermediate_points+2)); points[n_intermediate_points] = quadrature; } diff --git a/source/hp/dof_handler.cc b/source/hp/dof_handler.cc index 6467bed38a..6d735da572 100644 --- a/source/hp/dof_handler.cc +++ b/source/hp/dof_handler.cc @@ -17,7 +17,7 @@ #include #include #include -#include +#include #include #include #include @@ -70,7 +70,7 @@ namespace internal void ensure_existence_of_dof_identities (const FiniteElement &fe1, const FiniteElement &fe2, - std_cxx1x::shared_ptr &identities) + std_cxx11::shared_ptr &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 + std_cxx11::shared_ptr (new DoFIdentities(fe1.hp_vertex_dof_identities(fe2))); break; } @@ -90,7 +90,7 @@ namespace internal case 1: { identities = - std_cxx1x::shared_ptr + std_cxx11::shared_ptr (new DoFIdentities(fe1.hp_line_dof_identities(fe2))); break; } @@ -98,7 +98,7 @@ namespace internal case 2: { identities = - std_cxx1x::shared_ptr + std_cxx11::shared_ptr (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::pre_refinement_action, - std_cxx1x::ref(*this)))); + .connect (std_cxx11::bind (&DoFHandler::pre_refinement_action, + std_cxx11::ref(*this)))); tria_listeners.push_back (tria.signals.post_refinement - .connect (std_cxx1x::bind (&DoFHandler::post_refinement_action, - std_cxx1x::ref(*this)))); + .connect (std_cxx11::bind (&DoFHandler::post_refinement_action, + std_cxx11::ref(*this)))); tria_listeners.push_back (tria.signals.create - .connect (std_cxx1x::bind (&DoFHandler::post_refinement_action, - std_cxx1x::ref(*this)))); + .connect (std_cxx11::bind (&DoFHandler::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 > + Table<2,std_cxx11::shared_ptr > 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 > + Table<2,std_cxx11::shared_ptr > 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 > + Table<2,std_cxx11::shared_ptr > quad_dof_identities (finite_elements->size(), finite_elements->size()); diff --git a/source/hp/fe_collection.cc b/source/hp/fe_collection.cc index 834140145b..c0a814d269 100644 --- a/source/hp/fe_collection.cc +++ b/source/hp/fe_collection.cc @@ -71,7 +71,7 @@ namespace hp "same number of vector components!")); finite_elements - .push_back (std_cxx1x::shared_ptr >(new_fe.clone())); + .push_back (std_cxx11::shared_ptr >(new_fe.clone())); } diff --git a/source/hp/fe_values.cc b/source/hp/fe_values.cc index 782c3595d1..f430a9647b 100644 --- a/source/hp/fe_values.cc +++ b/source/hp/fe_values.cc @@ -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 + std_cxx11::shared_ptr (new FEValues ((*mapping_collection)[mapping_index], (*fe_collection)[fe_index], q_collection[q_index], diff --git a/source/hp/mapping_collection.cc b/source/hp/mapping_collection.cc index 06f111fdcf..77878ab517 100644 --- a/source/hp/mapping_collection.cc +++ b/source/hp/mapping_collection.cc @@ -35,7 +35,7 @@ namespace hp MappingCollection (const Mapping &mapping) { mappings - .push_back (std_cxx1x::shared_ptr >(mapping.clone())); + .push_back (std_cxx11::shared_ptr >(mapping.clone())); } @@ -76,7 +76,7 @@ namespace hp MappingCollection::push_back (const Mapping &new_mapping) { mappings - .push_back (std_cxx1x::shared_ptr >(new_mapping.clone())); + .push_back (std_cxx11::shared_ptr >(new_mapping.clone())); } //--------------------------------------------------------------------------- diff --git a/source/lac/trilinos_sparse_matrix.cc b/source/lac/trilinos_sparse_matrix.cc index b902f5b12c..587483a02a 100644 --- a/source/lac/trilinos_sparse_matrix.cc +++ b/source/lac/trilinos_sparse_matrix.cc @@ -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 graph; + std_cxx11::shared_ptr 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 graph, nonlocal_graph; + std_cxx11::shared_ptr graph, nonlocal_graph; if (input_row_map.Comm().NumProc() > 1) { graph.reset (new Epetra_CrsGraph (Copy, input_row_map, diff --git a/source/lac/trilinos_vector.cc b/source/lac/trilinos_vector.cc index 4bad57a8a6..261e2560ed 100644 --- a/source/lac/trilinos_vector.cc +++ b/source/lac/trilinos_vector.cc @@ -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 actual_vec; + std_cxx11::shared_ptr actual_vec; if ( import_data == true ) actual_vec.reset (new Epetra_FEVector (new_map)); else diff --git a/source/multigrid/mg_transfer_block.cc b/source/multigrid/mg_transfer_block.cc index 35442b79a0..681b65c6df 100644 --- a/source/multigrid/mg_transfer_block.cc +++ b/source/multigrid/mg_transfer_block.cc @@ -291,9 +291,9 @@ void MGTransferBlockBase::build_matrices ( for (unsigned int i=0; i (new BlockSparsityPattern)); + .push_back (std_cxx11::shared_ptr (new BlockSparsityPattern)); prolongation_matrices - .push_back (std_cxx1x::shared_ptr > (new BlockSparseMatrix)); + .push_back (std_cxx11::shared_ptr > (new BlockSparseMatrix)); } // two fields which will store the diff --git a/source/multigrid/mg_transfer_component.cc b/source/multigrid/mg_transfer_component.cc index 1be8a299e6..ffc8fa04e2 100644 --- a/source/multigrid/mg_transfer_component.cc +++ b/source/multigrid/mg_transfer_component.cc @@ -387,9 +387,9 @@ void MGTransferComponentBase::build_matrices ( for (unsigned int i=0; i (new BlockSparsityPattern)); + .push_back (std_cxx11::shared_ptr (new BlockSparsityPattern)); prolongation_matrices - .push_back (std_cxx1x::shared_ptr > (new BlockSparseMatrix)); + .push_back (std_cxx11::shared_ptr > (new BlockSparseMatrix)); } // two fields which will store the diff --git a/source/multigrid/mg_transfer_prebuilt.cc b/source/multigrid/mg_transfer_prebuilt.cc index f19388ce34..9b97b91896 100644 --- a/source/multigrid/mg_transfer_prebuilt.cc +++ b/source/multigrid/mg_transfer_prebuilt.cc @@ -141,9 +141,9 @@ void MGTransferPrebuilt::build_matrices ( for (unsigned int i=0; i::Sparsity> (new typename internal::MatrixSelector::Sparsity)); + (std_cxx11::shared_ptr::Sparsity> (new typename internal::MatrixSelector::Sparsity)); prolongation_matrices.push_back - (std_cxx1x::shared_ptr::Matrix> (new typename internal::MatrixSelector::Matrix)); + (std_cxx11::shared_ptr::Matrix> (new typename internal::MatrixSelector::Matrix)); } // two fields which will store the diff --git a/source/numerics/data_out.cc b/source/numerics/data_out.cc index 2249bfc706..5f1c39832a 100644 --- a/source/numerics/data_out.cc +++ b/source/numerics/data_out.cc @@ -42,7 +42,7 @@ namespace internal const unsigned int n_subdivisions, const std::vector &n_postprocessor_outputs, const Mapping &mapping, - const std::vector > > &finite_elements, + const std::vector > > &finite_elements, const UpdateFlags update_flags, const std::vector > &cell_to_patch_index_map) : @@ -448,11 +448,11 @@ void DataOut::build_patches (const Mapping 0) WorkStream::run (&all_cells[0], &all_cells[0]+all_cells.size(), - std_cxx1x::bind(&DataOut::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::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 &)>(), + std_cxx11::function &)>(), thread_data, sample_patch, // experimenting shows that we can make things run a bit diff --git a/source/numerics/data_out_dof_data.cc b/source/numerics/data_out_dof_data.cc index 50e8bce216..9b3cb62889 100644 --- a/source/numerics/data_out_dof_data.cc +++ b/source/numerics/data_out_dof_data.cc @@ -53,7 +53,7 @@ namespace internal const unsigned int n_subdivisions, const std::vector &n_postprocessor_outputs, const Mapping &mapping, - const std::vector > > &finite_elements, + const std::vector > > &finite_elements, const UpdateFlags update_flags, const bool use_face_values) : @@ -210,7 +210,7 @@ namespace internal template void ParallelDataBase:: - reinit_all_fe_values(std::vector > > &dof_data, + reinit_all_fe_values(std::vector > > &dof_data, const typename dealii::Triangulation::cell_iterator &cell, const unsigned int face) { @@ -780,9 +780,9 @@ add_data_vector (const VECTOR &vec, = new internal::DataOut::DataEntry(dofs, &vec, names, data_component_interpretation); if (actual_type == type_dof_data) - dof_data.push_back (std_cxx1x::shared_ptr >(new_entry)); + dof_data.push_back (std_cxx11::shared_ptr >(new_entry)); else - cell_data.push_back (std_cxx1x::shared_ptr >(new_entry)); + cell_data.push_back (std_cxx11::shared_ptr >(new_entry)); } @@ -809,7 +809,7 @@ add_data_vector (const VECTOR &vec, internal::DataOut::DataEntryBase *new_entry = new internal::DataOut::DataEntry(dofs, &vec, &data_postprocessor); - dof_data.push_back (std_cxx1x::shared_ptr >(new_entry)); + dof_data.push_back (std_cxx11::shared_ptr >(new_entry)); } @@ -832,7 +832,7 @@ add_data_vector (const DH &dof_handler, internal::DataOut::DataEntryBase *new_entry = new internal::DataOut::DataEntry(&dof_handler, &vec, &data_postprocessor); - dof_data.push_back (std_cxx1x::shared_ptr >(new_entry)); + dof_data.push_back (std_cxx11::shared_ptr >(new_entry)); } @@ -905,7 +905,7 @@ add_data_vector (const DH &dof_handler, internal::DataOut::DataEntryBase *new_entry = new internal::DataOut::DataEntry(&dof_handler, &data, names, data_component_interpretation); - dof_data.push_back (std_cxx1x::shared_ptr >(new_entry)); + dof_data.push_back (std_cxx11::shared_ptr >(new_entry)); } @@ -970,7 +970,7 @@ get_dataset_names () const // collect the names of dof // and cell data typedef - typename std::vector > >::const_iterator + typename std::vector > >::const_iterator data_iterator; for (data_iterator d=dof_data.begin(); @@ -990,16 +990,16 @@ get_dataset_names () const template -std::vector > +std::vector > DataOut_DoFData::get_vector_data_ranges () const { - std::vector > + std::vector > ranges; // collect the ranges of dof // and cell data typedef - typename std::vector > >::const_iterator + typename std::vector > >::const_iterator data_iterator; unsigned int output_component = 0; @@ -1045,7 +1045,7 @@ DataOut_DoFData::get_vector_data_ranges () const // finally add a corresponding // range - std_cxx1x::tuple + std_cxx11::tuple range (output_component, output_component+patch_space_dim-1, name); @@ -1094,12 +1094,12 @@ DataOut_DoFData::get_patches () const template -std::vector > > +std::vector > > DataOut_DoFData::get_finite_elements() const { const unsigned int dhdim = DH::dimension; const unsigned int dhspacedim = DH::space_dimension; - std::vector > > + std::vector > > finite_elements(this->dof_data.size()); for (unsigned int i=0; idof_data.size(); ++i) { diff --git a/source/numerics/data_out_dof_data.inst.in b/source/numerics/data_out_dof_data.inst.in index ea420b3519..c3ef3292db 100644 --- a/source/numerics/data_out_dof_data.inst.in +++ b/source/numerics/data_out_dof_data.inst.in @@ -422,7 +422,7 @@ for (DH : DOFHANDLER_TEMPLATES; deal_II_dimension : DIMENSIONS; deal_II_space_di void ParallelDataBase:: reinit_all_fe_values > - (std::vector > > > &dof_data, + (std::vector > > > &dof_data, const dealii::Triangulation::cell_iterator &cell, const unsigned int face); #endif diff --git a/source/numerics/data_out_faces.cc b/source/numerics/data_out_faces.cc index 992839c741..2b7c8b3b43 100644 --- a/source/numerics/data_out_faces.cc +++ b/source/numerics/data_out_faces.cc @@ -41,7 +41,7 @@ namespace internal const unsigned int n_subdivisions, const std::vector &n_postprocessor_outputs, const Mapping &mapping, - const std::vector > > &finite_elements, + const std::vector > > &finite_elements, const UpdateFlags update_flags) : internal::DataOut:: @@ -334,11 +334,11 @@ void DataOutFaces::build_patches (const Mapping &mapping, // now build the patches in parallel WorkStream::run (&all_faces[0], &all_faces[0]+all_faces.size(), - std_cxx1x::bind(&DataOutFaces::build_one_patch, - this, std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3), - std_cxx1x::bind(&internal::DataOutFaces:: + std_cxx11::bind(&DataOutFaces::build_one_patch, + this, std_cxx11::_1, std_cxx11::_2, std_cxx11::_3), + std_cxx11::bind(&internal::DataOutFaces:: append_patch_to_list, - std_cxx1x::_1, std_cxx1x::ref(this->patches)), + std_cxx11::_1, std_cxx11::ref(this->patches)), thread_data, sample_patch); } diff --git a/source/numerics/data_out_rotation.cc b/source/numerics/data_out_rotation.cc index 98d7c51cd4..efe34a46f0 100644 --- a/source/numerics/data_out_rotation.cc +++ b/source/numerics/data_out_rotation.cc @@ -55,7 +55,7 @@ namespace internal const unsigned int n_patches_per_circle, const std::vector &n_postprocessor_outputs, const Mapping &mapping, - const std::vector > > &finite_elements, + const std::vector > > &finite_elements, const UpdateFlags update_flags) : internal::DataOut:: @@ -473,11 +473,11 @@ void DataOutRotation::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::build_one_patch, - this, std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3), - std_cxx1x::bind(&internal::DataOutRotation + std_cxx11::bind(&DataOutRotation::build_one_patch, + this, std_cxx11::_1, std_cxx11::_2, std_cxx11::_3), + std_cxx11::bind(&internal::DataOutRotation ::append_patch_to_list, - std_cxx1x::_1, std_cxx1x::ref(this->patches)), + std_cxx11::_1, std_cxx11::ref(this->patches)), thread_data, new_patches); } diff --git a/source/numerics/derivative_approximation.cc b/source/numerics/derivative_approximation.cc index 93970e636b..044d12e5ed 100644 --- a/source/numerics/derivative_approximation.cc +++ b/source/numerics/derivative_approximation.cc @@ -930,25 +930,25 @@ namespace DerivativeApproximation template class DH, class InputVector, int spacedim> void - approximate (SynchronousIterators::active_cell_iterator,Vector::iterator> > const &cell, + approximate (SynchronousIterators::active_cell_iterator,Vector::iterator> > const &cell, const Mapping &mapping, const DH &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 - (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::active_cell_iterator,Vector::iterator> + typedef std_cxx11::tuple::active_cell_iterator,Vector::iterator> Iterators; SynchronousIterators 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 const &, + static_cast const &, Assembler::Scratch const &, Assembler::CopyData &)> > - (std_cxx1x::bind(&approximate, - std_cxx1x::_1, - std_cxx1x::cref(mapping), - std_cxx1x::cref(dof_handler), - std_cxx1x::cref(solution),component)), - std_cxx1x::function (), + (std_cxx11::bind(&approximate, + std_cxx11::_1, + std_cxx11::cref(mapping), + std_cxx11::cref(dof_handler), + std_cxx11::cref(solution),component)), + std_cxx11::function (), internal::Assembler::Scratch (),internal::Assembler::CopyData ()); } diff --git a/source/numerics/error_estimator.cc b/source/numerics/error_estimator.cc index 19fbf0c542..d6a1c986b5 100644 --- a/source/numerics/error_estimator.cc +++ b/source/numerics/error_estimator.cc @@ -39,7 +39,7 @@ #include #include -#include +#include #include #include @@ -978,10 +978,10 @@ estimate (const Mapping &mapping, // now let's work on all those cells: WorkStream::run (dof_handler.begin_active(), static_cast(dof_handler.end()), - std_cxx1x::bind (&internal::estimate_one_cell, - std_cxx1x::_1, std_cxx1x::_2, std_cxx1x::_3, std_cxx1x::ref(solutions)), - std_cxx1x::bind (&internal::copy_local_to_global, - std_cxx1x::_1, std_cxx1x::ref(face_integrals)), + std_cxx11::bind (&internal::estimate_one_cell, + std_cxx11::_1, std_cxx11::_2, std_cxx11::_3, std_cxx11::ref(solutions)), + std_cxx11::bind (&internal::copy_local_to_global, + std_cxx11::_1, std_cxx11::ref(face_integrals)), parallel_data, sample_local_face_integrals); diff --git a/source/numerics/error_estimator_1d.cc b/source/numerics/error_estimator_1d.cc index d46e35f25d..0e37e2eb96 100644 --- a/source/numerics/error_estimator_1d.cc +++ b/source/numerics/error_estimator_1d.cc @@ -39,7 +39,7 @@ #include #include -#include +#include #include #include diff --git a/source/numerics/matrix_tools.cc b/source/numerics/matrix_tools.cc index a81921da4a..a24fc83867 100644 --- a/source/numerics/matrix_tools.cc +++ b/source/numerics/matrix_tools.cc @@ -676,9 +676,9 @@ namespace MatrixCreator WorkStream::run (dof.begin_active(), static_cast::active_cell_iterator>(dof.end()), &MatrixCreator::internal::mass_assembler::active_cell_iterator>, - std_cxx1x::bind (&MatrixCreator::internal:: + std_cxx11::bind (&MatrixCreator::internal:: copy_local_to_global, Vector >, - std_cxx1x::_1, &matrix, (Vector *)0), + std_cxx11::_1, &matrix, (Vector *)0), assembler_data, copy_data); } @@ -732,9 +732,9 @@ namespace MatrixCreator WorkStream::run (dof.begin_active(), static_cast::active_cell_iterator>(dof.end()), &MatrixCreator::internal::mass_assembler::active_cell_iterator>, - std_cxx1x::bind(&MatrixCreator::internal:: + std_cxx11::bind(&MatrixCreator::internal:: copy_local_to_global, Vector >, - 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::active_cell_iterator>(dof.end()), &MatrixCreator::internal::mass_assembler::active_cell_iterator>, - std_cxx1x::bind (&MatrixCreator::internal:: + std_cxx11::bind (&MatrixCreator::internal:: copy_local_to_global, Vector >, - std_cxx1x::_1, &matrix, (Vector *)0), + std_cxx11::_1, &matrix, (Vector *)0), assembler_data, copy_data); } @@ -839,9 +839,9 @@ namespace MatrixCreator WorkStream::run (dof.begin_active(), static_cast::active_cell_iterator>(dof.end()), &MatrixCreator::internal::mass_assembler::active_cell_iterator>, - std_cxx1x::bind (&MatrixCreator::internal:: + std_cxx11::bind (&MatrixCreator::internal:: copy_local_to_global, Vector >, - 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 > copy_data; WorkStream::run(dof.begin_active(),dof.end(), - static_cast::active_cell_iterator + static_cast::active_cell_iterator const &,MatrixCreator::internal::AssemblerBoundary::Scratch const &, MatrixCreator::internal::AssemblerBoundary::CopyData > &)> > - (std_cxx1x::bind(&create_boundary_mass_matrix_1,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 > const &)> > (std_cxx1x::bind( + (std_cxx11::bind(&create_boundary_mass_matrix_1,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 > const &)> > (std_cxx11::bind( ©_boundary_mass_matrix_1, - 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 > copy_data; WorkStream::run(dof.begin_active(),dof.end(), - static_cast::active_cell_iterator + static_cast::active_cell_iterator const &,MatrixCreator::internal::AssemblerBoundary::Scratch const &, MatrixCreator::internal::AssemblerBoundary::CopyData > &)> > - (std_cxx1x::bind( &create_hp_boundary_mass_matrix_1,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_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 > const &)> > ( - std_cxx1x::bind( ©_hp_boundary_mass_matrix_1, - 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( ©_hp_boundary_mass_matrix_1, + 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::active_cell_iterator>(dof.end()), &MatrixCreator::internal::laplace_assembler::active_cell_iterator>, - std_cxx1x::bind (&MatrixCreator::internal:: + std_cxx11::bind (&MatrixCreator::internal:: copy_local_to_global, Vector >, - std_cxx1x::_1, + std_cxx11::_1, &matrix, (Vector *)NULL), assembler_data, @@ -1747,9 +1747,9 @@ namespace MatrixCreator WorkStream::run (dof.begin_active(), static_cast::active_cell_iterator>(dof.end()), &MatrixCreator::internal::laplace_assembler::active_cell_iterator>, - std_cxx1x::bind (&MatrixCreator::internal:: + std_cxx11::bind (&MatrixCreator::internal:: copy_local_to_global, Vector >, - std_cxx1x::_1, + std_cxx11::_1, &matrix, &rhs_vector), assembler_data, @@ -1802,9 +1802,9 @@ namespace MatrixCreator WorkStream::run (dof.begin_active(), static_cast::active_cell_iterator>(dof.end()), &MatrixCreator::internal::laplace_assembler::active_cell_iterator>, - std_cxx1x::bind (&MatrixCreator::internal:: + std_cxx11::bind (&MatrixCreator::internal:: copy_local_to_global, Vector >, - std_cxx1x::_1, + std_cxx11::_1, &matrix, (Vector *)0), assembler_data, @@ -1856,9 +1856,9 @@ namespace MatrixCreator WorkStream::run (dof.begin_active(), static_cast::active_cell_iterator>(dof.end()), &MatrixCreator::internal::laplace_assembler::active_cell_iterator>, - std_cxx1x::bind (&MatrixCreator::internal:: + std_cxx11::bind (&MatrixCreator::internal:: copy_local_to_global, Vector >, - std_cxx1x::_1, + std_cxx11::_1, &matrix, &rhs_vector), assembler_data, diff --git a/source/numerics/point_value_history.cc b/source/numerics/point_value_history.cc index ee0d8c9cd2..68cdab41c8 100644 --- a/source/numerics/point_value_history.cc +++ b/source/numerics/point_value_history.cc @@ -94,8 +94,8 @@ PointValueHistory::PointValueHistory (const DoFHandler &dof_handler, = std::vector > (n_indep, std::vector (0)); indep_names = std::vector (); - tria_listener = dof_handler.get_tria().signals.any_change.connect (std_cxx1x::bind (&PointValueHistory::tria_change_listener, - std_cxx1x::ref(*this))); + tria_listener = dof_handler.get_tria().signals.any_change.connect (std_cxx11::bind (&PointValueHistory::tria_change_listener, + std_cxx11::ref(*this))); } @@ -124,8 +124,8 @@ PointValueHistory::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::tria_change_listener, - std_cxx1x::ref(*this))); + tria_listener = dof_handler->get_tria().signals.any_change.connect (std_cxx11::bind (&PointValueHistory::tria_change_listener, + std_cxx11::ref(*this))); } } @@ -156,8 +156,8 @@ PointValueHistory::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::tria_change_listener, - std_cxx1x::ref(*this))); + tria_listener = dof_handler->get_tria().signals.any_change.connect (std_cxx11::bind (&PointValueHistory::tria_change_listener, + std_cxx11::ref(*this))); } return * this; diff --git a/source/numerics/time_dependent.cc b/source/numerics/time_dependent.cc index 97db6b277b..314f8d8a7c 100644 --- a/source/numerics/time_dependent.cc +++ b/source/numerics/time_dependent.cc @@ -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); } -- 2.39.5