From: Wolfgang Bangerth Date: Sun, 19 Mar 2023 20:25:08 +0000 (-0600) Subject: Use std_cxx20::type_identity_t instead of identity<...>::type. X-Git-Tag: v9.5.0-rc1~429^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=e34647e8ff2206243a81837370c58d37653fbee0;p=dealii.git Use std_cxx20::type_identity_t instead of identity<...>::type. --- diff --git a/include/deal.II/base/graph_coloring.h b/include/deal.II/base/graph_coloring.h index 50aeed6b96..8efeccdd34 100644 --- a/include/deal.II/base/graph_coloring.h +++ b/include/deal.II/base/graph_coloring.h @@ -108,10 +108,10 @@ namespace GraphColoring template std::vector> create_partitioning( - const Iterator & begin, - const typename identity::type &end, + const Iterator & begin, + const std_cxx20::type_identity_t &end, const std::function( - const Iterator &)> & get_conflict_indices) + const Iterator &)> & get_conflict_indices) { // Number of iterators. unsigned int n_iterators = 0; @@ -539,10 +539,10 @@ namespace GraphColoring template std::vector> make_graph_coloring( - const Iterator & begin, - const typename identity::type & end, + const Iterator & begin, + const std_cxx20::type_identity_t & end, const std::function( - const typename identity::type &)> &get_conflict_indices) + const std_cxx20::type_identity_t &)> &get_conflict_indices) { Assert(begin != end, ExcMessage( diff --git a/include/deal.II/base/iterator_range.h b/include/deal.II/base/iterator_range.h index b9bc60dd9b..6e8de5b444 100644 --- a/include/deal.II/base/iterator_range.h +++ b/include/deal.II/base/iterator_range.h @@ -290,8 +290,8 @@ private: */ template IteratorRange -make_iterator_range(const BaseIterator & begin, - const typename identity::type &end) +make_iterator_range(const BaseIterator & begin, + const std_cxx20::type_identity_t &end) { IteratorRange ir(begin, end); return ir; diff --git a/include/deal.II/base/mutable_bind.h b/include/deal.II/base/mutable_bind.h index 53e40c96af..ba87083f11 100644 --- a/include/deal.II/base/mutable_bind.h +++ b/include/deal.II/base/mutable_bind.h @@ -186,7 +186,7 @@ namespace Utilities template MutableBind mutable_bind(ReturnType (*function)(FunctionArgs...), - typename identity::type &&...arguments); + std_cxx20::type_identity_t &&...arguments); /** * Same as above, using a std::function object. @@ -194,7 +194,7 @@ namespace Utilities template MutableBind mutable_bind(std::function, - typename identity::type &&...arguments); + std_cxx20::type_identity_t &&...arguments); /** * Create a MutableBind object from a function pointer, with uninitialized @@ -292,7 +292,7 @@ namespace Utilities template MutableBind mutable_bind(ReturnType (*function)(FunctionArgs...), - typename identity::type &&...arguments) + std_cxx20::type_identity_t &&...arguments) { return MutableBind(function, std::move(arguments)...); @@ -312,7 +312,7 @@ namespace Utilities template MutableBind mutable_bind(std::function function, - typename identity::type &&...arguments) + std_cxx20::type_identity_t &&...arguments) { return MutableBind(function, std::move(arguments)...); diff --git a/include/deal.II/base/parallel.h b/include/deal.II/base/parallel.h index 4da420b7eb..4a5543ae8a 100644 --- a/include/deal.II/base/parallel.h +++ b/include/deal.II/base/parallel.h @@ -394,10 +394,10 @@ namespace parallel */ template DEAL_II_CXX20_REQUIRES((std::invocable)) - void apply_to_subranges(const Iterator & begin, - const typename identity::type &end, - const Function & f, - const unsigned int grainsize) + void apply_to_subranges(const Iterator & begin, + const std_cxx20::type_identity_t &end, + const Function & f, + const unsigned int grainsize) { #ifndef DEAL_II_WITH_TBB // make sure we don't get compiler @@ -544,9 +544,9 @@ namespace parallel std::convertible_to, ResultType>)) ResultType - accumulate_from_subranges(const Function & f, - const Iterator & begin, - const typename identity::type &end, + accumulate_from_subranges(const Function & f, + const Iterator & begin, + const std_cxx20::type_identity_t &end, const unsigned int grainsize) { #ifndef DEAL_II_WITH_TBB diff --git a/include/deal.II/base/std_cxx20/type_traits.h b/include/deal.II/base/std_cxx20/type_traits.h index 95bb6b4af0..30851c3714 100644 --- a/include/deal.II/base/std_cxx20/type_traits.h +++ b/include/deal.II/base/std_cxx20/type_traits.h @@ -43,7 +43,7 @@ namespace std_cxx20 * written as * @code * template - * void f(T, typename identity::type); + * void f(T, std_cxx20::type_identity_t); * @endcode * then the call becomes valid: the type T is not deducible * from the second argument to the function, so only the first argument @@ -73,7 +73,7 @@ namespace std_cxx20 * achieve this by writing the code as follows: * @code * template - * void forward_call(RT (*p) (A), typename identity::type a) + * void forward_call(RT (*p) (A), std_cxx20::type_identity_t a) * { * p(a); * } diff --git a/include/deal.II/base/thread_management.h b/include/deal.II/base/thread_management.h index 26b2b8b1a1..c5e41dbdc8 100644 --- a/include/deal.II/base/thread_management.h +++ b/include/deal.II/base/thread_management.h @@ -815,7 +815,7 @@ namespace Threads */ template DEAL_II_DEPRECATED inline Thread - new_thread(RT (*fun_ptr)(Args...), typename identity::type... args) + new_thread(RT (*fun_ptr)(Args...), std_cxx20::type_identity_t... args) { // See the comment in the first new_thread() implementation DEAL_II_DISABLE_EXTRA_DIAGNOSTICS @@ -837,8 +837,8 @@ namespace Threads template DEAL_II_DEPRECATED inline Thread new_thread(RT (C::*fun_ptr)(Args...), - typename identity::type &c, - typename identity::type... args) + std_cxx20::type_identity_t &c, + std_cxx20::type_identity_t... args) { // NOLINTNEXTLINE(modernize-avoid-bind) silence clang-tidy return new_thread(std::function(std::bind( @@ -855,8 +855,8 @@ namespace Threads template DEAL_II_DEPRECATED inline Thread new_thread(RT (C::*fun_ptr)(Args...) const, - typename identity::type &c, - typename identity::type... args) + std_cxx20::type_identity_t &c, + std_cxx20::type_identity_t... args) { // See the comment in the first new_thread() implementation DEAL_II_DISABLE_EXTRA_DIAGNOSTICS @@ -1587,7 +1587,7 @@ namespace Threads */ template inline Task - new_task(RT (*fun_ptr)(Args...), typename identity::type... args) + new_task(RT (*fun_ptr)(Args...), std_cxx20::type_identity_t... args) { auto dummy = std::make_tuple(internal::maybe_make_ref::act(args)...); return new_task( @@ -1605,8 +1605,8 @@ namespace Threads template inline Task new_task(RT (C::*fun_ptr)(Args...), - typename identity::type &c, - typename identity::type... args) + std_cxx20::type_identity_t &c, + std_cxx20::type_identity_t... args) { // NOLINTNEXTLINE(modernize-avoid-bind) silence clang-tidy return new_task(std::function(std::bind( @@ -1622,8 +1622,8 @@ namespace Threads template inline Task new_task(RT (C::*fun_ptr)(Args...) const, - typename identity::type &c, - typename identity::type... args) + std_cxx20::type_identity_t &c, + std_cxx20::type_identity_t... args) { // NOLINTNEXTLINE(modernize-avoid-bind) silence clang-tidy return new_task(std::function(std::bind( diff --git a/include/deal.II/base/work_stream.h b/include/deal.II/base/work_stream.h index 63fe6e0a2d..c212a8cdd2 100644 --- a/include/deal.II/base/work_stream.h +++ b/include/deal.II/base/work_stream.h @@ -469,14 +469,14 @@ namespace WorkStream typename ScratchData, typename CopyData> void - run(const Iterator & begin, - const typename identity::type &end, - Worker worker, - Copier copier, - const ScratchData & sample_scratch_data, - const CopyData & sample_copy_data, - const unsigned int queue_length, - const unsigned int chunk_size) + run(const Iterator & begin, + const std_cxx20::type_identity_t &end, + Worker worker, + Copier copier, + const ScratchData & sample_scratch_data, + const CopyData & sample_copy_data, + const unsigned int queue_length, + const unsigned int chunk_size) { using ItemType = typename IteratorRangeToItemStream void - run(const Iterator & begin, - const typename identity::type &end, - Worker worker, - Copier copier, - const ScratchData & sample_scratch_data, - const CopyData & sample_copy_data) + run(const Iterator & begin, + const std_cxx20::type_identity_t &end, + Worker worker, + Copier copier, + const ScratchData & sample_scratch_data, + const CopyData & sample_copy_data) { // need to copy the sample since it is marked const ScratchData scratch_data = sample_scratch_data; @@ -1119,12 +1119,12 @@ namespace WorkStream typename ScratchData, typename CopyData> void - run(const Iterator & begin, - const typename identity::type &end, - Worker worker, - Copier copier, - const ScratchData & sample_scratch_data, - const CopyData & sample_copy_data, + run(const Iterator & begin, + const std_cxx20::type_identity_t &end, + Worker worker, + Copier copier, + const ScratchData & sample_scratch_data, + const CopyData & sample_copy_data, const unsigned int queue_length = 2 * MultithreadInfo::n_threads(), const unsigned int chunk_size = 8) { @@ -1356,9 +1356,9 @@ namespace WorkStream typename ScratchData, typename CopyData> void - run(const Iterator & begin, - const typename identity::type &end, - MainClass & main_object, + run(const Iterator & begin, + const std_cxx20::type_identity_t &end, + MainClass & main_object, void (MainClass::*worker)(const Iterator &, ScratchData &, CopyData &), void (MainClass::*copier)(const CopyData &), const ScratchData &sample_scratch_data, @@ -1390,8 +1390,8 @@ namespace WorkStream typename ScratchData, typename CopyData> void - run(const IteratorOverIterators & begin, - const IteratorOverIterators::type> &end, + run(const IteratorOverIterators & begin, + const IteratorOverIterators> &end, MainClass &main_object, void (MainClass::*worker)(const Iterator &, ScratchData &, CopyData &), void (MainClass::*copier)(const CopyData &), @@ -1433,17 +1433,18 @@ namespace WorkStream typename CopyData, typename = std::enable_if_t>> void - run(IteratorRangeType iterator_range, - MainClass & main_object, - void (MainClass::*worker)( - const typename identity::type::iterator &, - ScratchData &, - CopyData &), - void (MainClass::*copier)(const CopyData &), - const ScratchData &sample_scratch_data, - const CopyData & sample_copy_data, - const unsigned int queue_length = 2 * MultithreadInfo::n_threads(), - const unsigned int chunk_size = 8) + run( + IteratorRangeType iterator_range, + MainClass & main_object, + void (MainClass::*worker)( + const typename std_cxx20::type_identity_t::iterator &, + ScratchData &, + CopyData &), + void (MainClass::*copier)(const CopyData &), + const ScratchData &sample_scratch_data, + const CopyData & sample_copy_data, + const unsigned int queue_length = 2 * MultithreadInfo::n_threads(), + const unsigned int chunk_size = 8) { // Call the function above run(std::begin(iterator_range), diff --git a/include/deal.II/dofs/dof_renumbering.h b/include/deal.II/dofs/dof_renumbering.h index 0ae8e20e70..b17989e742 100644 --- a/include/deal.II/dofs/dof_renumbering.h +++ b/include/deal.II/dofs/dof_renumbering.h @@ -698,7 +698,7 @@ namespace DoFRenumbering types::global_dof_index compute_component_wise(std::vector &new_dof_indices, const CellIterator & start, - const typename identity::type &end, + const std_cxx20::type_identity_t &end, const std::vector &target_component, const bool is_level_operation); diff --git a/include/deal.II/dofs/dof_tools.h b/include/deal.II/dofs/dof_tools.h index a2431e8ece..71037389f6 100644 --- a/include/deal.II/dofs/dof_tools.h +++ b/include/deal.II/dofs/dof_tools.h @@ -1029,9 +1029,9 @@ namespace DoFTools template void make_periodicity_constraints( - const FaceIterator & face_1, - const typename identity::type &face_2, - AffineConstraints & constraints, + const FaceIterator & face_1, + const std_cxx20::type_identity_t &face_2, + AffineConstraints & constraints, const ComponentMask & component_mask = ComponentMask(), const bool face_orientation = true, const bool face_flip = false, diff --git a/include/deal.II/hp/refinement.h b/include/deal.II/hp/refinement.h index 08fef0f7c0..9033704d83 100644 --- a/include/deal.II/hp/refinement.h +++ b/include/deal.II/hp/refinement.h @@ -211,9 +211,9 @@ namespace hp const Vector & criteria, const Number p_refine_threshold, const Number p_coarsen_threshold, - const ComparisonFunction::type> + const ComparisonFunction> &compare_refine = std::greater_equal(), - const ComparisonFunction::type> + const ComparisonFunction> &compare_coarsen = std::less_equal()); /** @@ -254,9 +254,9 @@ namespace hp const Vector & criteria, const double p_refine_fraction = 0.5, const double p_coarsen_fraction = 0.5, - const ComparisonFunction::type> + const ComparisonFunction> &compare_refine = std::greater_equal(), - const ComparisonFunction::type> + const ComparisonFunction> &compare_coarsen = std::less_equal()); /** @@ -298,9 +298,9 @@ namespace hp const Vector & criteria, const double p_refine_fraction = 0.5, const double p_coarsen_fraction = 0.5, - const ComparisonFunction::type> + const ComparisonFunction> &compare_refine = std::greater_equal(), - const ComparisonFunction::type> + const ComparisonFunction> &compare_coarsen = std::less_equal()); /** @@ -357,11 +357,12 @@ namespace hp template void p_adaptivity_from_reference( - const DoFHandler & dof_handler, - const Vector & criteria, - const Vector & references, - const ComparisonFunction::type> &compare_refine, - const ComparisonFunction::type> + const DoFHandler &dof_handler, + const Vector & criteria, + const Vector & references, + const ComparisonFunction> + &compare_refine, + const ComparisonFunction> &compare_coarsen); /** diff --git a/include/deal.II/meshworker/loop.h b/include/deal.II/meshworker/loop.h index ee9293abb0..3f28a88d18 100644 --- a/include/deal.II/meshworker/loop.h +++ b/include/deal.II/meshworker/loop.h @@ -436,10 +436,10 @@ namespace MeshWorker class ASSEMBLER, class ITERATOR> void - loop(ITERATOR begin, - typename identity::type end, - DOFINFO & dinfo, - INFOBOX & info, + loop(ITERATOR begin, + std_cxx20::type_identity_t end, + DOFINFO & dinfo, + INFOBOX & info, const std::function &cell_worker, const std::function @@ -491,7 +491,7 @@ namespace MeshWorker template void integration_loop(ITERATOR begin, - typename identity::type end, + std_cxx20::type_identity_t end, DoFInfo & dof_info, IntegrationInfoBox & box, const LocalIntegrator &integrator, diff --git a/include/deal.II/meshworker/mesh_loop.h b/include/deal.II/meshworker/mesh_loop.h index 699264551e..1df5392a23 100644 --- a/include/deal.II/meshworker/mesh_loop.h +++ b/include/deal.II/meshworker/mesh_loop.h @@ -299,13 +299,13 @@ namespace MeshWorker const unsigned int queue_length = 2 * MultithreadInfo::n_threads(), const unsigned int chunk_size = 8 #else - const CellIteratorType & begin, - const typename identity::type &end, + const CellIteratorType & begin, + const std_cxx20::type_identity_t &end, - const typename identity>::type + const std_cxx20::type_identity_t> &cell_worker, - const typename identity>::type + const std_cxx20::type_identity_t> &copier, const ScratchData &sample_scratch_data, @@ -313,31 +313,33 @@ namespace MeshWorker const AssembleFlags flags = assemble_own_cells, - const typename identity>::type - &boundary_worker = std::function(), - - const typename identity>::type - &face_worker = std::function(), + const std_cxx20::type_identity_t< + std::function> &boundary_worker = + std::function(), + + const std_cxx20::type_identity_t< + std::function> &face_worker = + std::function(), const unsigned int queue_length = 2 * MultithreadInfo::n_threads(), const unsigned int chunk_size = 8 @@ -713,10 +715,10 @@ namespace MeshWorker void mesh_loop( IteratorRange iterator_range, - const typename identity>::type + const std_cxx20::type_identity_t> &cell_worker, - const typename identity>::type + const std_cxx20::type_identity_t> &copier, const ScratchData &sample_scratch_data, @@ -724,31 +726,33 @@ namespace MeshWorker const AssembleFlags flags = assemble_own_cells, - const typename identity>::type - &boundary_worker = std::function(), - - const typename identity>::type - &face_worker = std::function(), + const std_cxx20::type_identity_t< + std::function> &boundary_worker = + std::function(), + + const std_cxx20::type_identity_t< + std::function> &face_worker = + std::function(), const unsigned int queue_length = 2 * MultithreadInfo::n_threads(), const unsigned int chunk_size = 8) @@ -834,9 +838,9 @@ namespace MeshWorker class CopyData, class MainClass> void - mesh_loop(const CellIteratorType & begin, - const typename identity::type &end, - MainClass & main_class, + mesh_loop(const CellIteratorType & begin, + const std_cxx20::type_identity_t &end, + MainClass & main_class, void (MainClass::*cell_worker)(const CellIteratorType &, ScratchData &, CopyData &), diff --git a/source/dofs/dof_renumbering.cc b/source/dofs/dof_renumbering.cc index 4a772b49f6..27173191e8 100644 --- a/source/dofs/dof_renumbering.cc +++ b/source/dofs/dof_renumbering.cc @@ -753,7 +753,7 @@ namespace DoFRenumbering types::global_dof_index compute_component_wise(std::vector &new_indices, const CellIterator & start, - const typename identity::type &end, + const std_cxx20::type_identity_t &end, const std::vector &component_order_arg, const bool is_level_operation) { diff --git a/source/dofs/dof_tools_constraints.cc b/source/dofs/dof_tools_constraints.cc index 1823435b49..0648e91e36 100644 --- a/source/dofs/dof_tools_constraints.cc +++ b/source/dofs/dof_tools_constraints.cc @@ -1839,15 +1839,15 @@ namespace DoFTools template void set_periodicity_constraints( - const FaceIterator & face_1, - const typename identity::type &face_2, - const FullMatrix & transformation, - AffineConstraints & affine_constraints, - const ComponentMask & component_mask, - const bool face_orientation, - const bool face_flip, - const bool face_rotation, - const number periodicity_factor) + const FaceIterator & face_1, + const std_cxx20::type_identity_t &face_2, + const FullMatrix & transformation, + AffineConstraints & affine_constraints, + const ComponentMask & component_mask, + const bool face_orientation, + const bool face_flip, + const bool face_rotation, + const number periodicity_factor) { static const int dim = FaceIterator::AccessorType::dimension; static const int spacedim = FaceIterator::AccessorType::space_dimension; @@ -2290,16 +2290,16 @@ namespace DoFTools template void make_periodicity_constraints( - const FaceIterator & face_1, - const typename identity::type &face_2, - AffineConstraints & affine_constraints, - const ComponentMask & component_mask, - const bool face_orientation, - const bool face_flip, - const bool face_rotation, - const FullMatrix & matrix, - const std::vector & first_vector_components, - const number periodicity_factor) + const FaceIterator & face_1, + const std_cxx20::type_identity_t &face_2, + AffineConstraints & affine_constraints, + const ComponentMask & component_mask, + const bool face_orientation, + const bool face_flip, + const bool face_rotation, + const FullMatrix & matrix, + const std::vector & first_vector_components, + const number periodicity_factor) { static const int dim = FaceIterator::AccessorType::dimension; static const int spacedim = FaceIterator::AccessorType::space_dimension; diff --git a/source/grid/grid_tools_dof_handlers.cc b/source/grid/grid_tools_dof_handlers.cc index 25b422a3c2..3f2e3ee59e 100644 --- a/source/grid/grid_tools_dof_handlers.cc +++ b/source/grid/grid_tools_dof_handlers.cc @@ -2024,7 +2024,7 @@ namespace GridTools void match_periodic_face_pairs( std::set> &pairs1, - std::set::type, unsigned int>> + std::set, unsigned int>> & pairs2, const unsigned int direction, std::vector> &matched_pairs, diff --git a/source/hp/refinement.cc b/source/hp/refinement.cc index c717d71603..6ac4a1f1e7 100644 --- a/source/hp/refinement.cc +++ b/source/hp/refinement.cc @@ -112,8 +112,9 @@ namespace hp const Vector & criteria, const Number p_refine_threshold, const Number p_coarsen_threshold, - const ComparisonFunction::type> &compare_refine, - const ComparisonFunction::type> + const ComparisonFunction> + &compare_refine, + const ComparisonFunction> &compare_coarsen) { if (dof_handler.get_fe_collection().size() == 0) @@ -150,8 +151,9 @@ namespace hp const Vector & criteria, const double p_refine_fraction, const double p_coarsen_fraction, - const ComparisonFunction::type> &compare_refine, - const ComparisonFunction::type> + const ComparisonFunction> + &compare_refine, + const ComparisonFunction> &compare_coarsen) { if (dof_handler.get_fe_collection().size() == 0) @@ -246,8 +248,9 @@ namespace hp const Vector & criteria, const double p_refine_fraction, const double p_coarsen_fraction, - const ComparisonFunction::type> &compare_refine, - const ComparisonFunction::type> + const ComparisonFunction> + &compare_refine, + const ComparisonFunction> &compare_coarsen) { if (dof_handler.get_fe_collection().size() == 0) @@ -498,11 +501,12 @@ namespace hp template void p_adaptivity_from_reference( - const DoFHandler & dof_handler, - const Vector & criteria, - const Vector & references, - const ComparisonFunction::type> &compare_refine, - const ComparisonFunction::type> + const DoFHandler &dof_handler, + const Vector & criteria, + const Vector & references, + const ComparisonFunction> + &compare_refine, + const ComparisonFunction> &compare_coarsen) { if (dof_handler.get_fe_collection().size() == 0) diff --git a/source/hp/refinement.inst.in b/source/hp/refinement.inst.in index 4f6aae77e4..3645cfaa3d 100644 --- a/source/hp/refinement.inst.in +++ b/source/hp/refinement.inst.in @@ -65,8 +65,8 @@ for (deal_II_dimension : DIMENSIONS; S : REAL_SCALARS; const Vector &, const S, const S, - const ComparisonFunction::type> &, - const ComparisonFunction::type> &); + const ComparisonFunction> &, + const ComparisonFunction> &); template void p_adaptivity_from_relative_threshold &, const double, const double, - const ComparisonFunction::type> &, - const ComparisonFunction::type> &); + const ComparisonFunction> &, + const ComparisonFunction> &); template void p_adaptivity_fixed_number &, const double, const double, - const ComparisonFunction::type> &, - const ComparisonFunction::type> &); + const ComparisonFunction> &, + const ComparisonFunction> &); template void p_adaptivity_from_regularity &, const Vector &, const Vector &, - const ComparisonFunction::type> &, - const ComparisonFunction::type> &); + const ComparisonFunction> &, + const ComparisonFunction> &); template void predict_error( diff --git a/tests/mpi/mesh_worker_01.cc b/tests/mpi/mesh_worker_01.cc index 33ee628ac0..b34b688902 100644 --- a/tests/mpi/mesh_worker_01.cc +++ b/tests/mpi/mesh_worker_01.cc @@ -105,7 +105,7 @@ test_simple(DoFHandler &dofs, MeshWorker::LoopControl &lctrl) MeshWorker::DoFInfo dof_info(dofs.block_info()); // integration_loop(ITERATOR begin, - // typename identity::type end, + // std_cxx20::type_identity_t end, // DOFINFO &dinfo, // INFOBOX &info, // const std::function &dofs, MeshWorker::LoopControl &lctrl) MeshWorker::DoFInfo dof_info(dofs.block_info()); // integration_loop(ITERATOR begin, - // typename identity::type end, + // std_cxx20::type_identity_t end, // DOFINFO &dinfo, // INFOBOX &info, // const std::function &dofs, MeshWorker::LoopControl &lctrl) MeshWorker::DoFInfo dof_info(dofs.block_info()); // integration_loop(ITERATOR begin, - // typename identity::type end, + // std_cxx20::type_identity_t end, // DOFINFO &dinfo, // INFOBOX &info, // const std::function &dofs, MeshWorker::LoopControl &lctrl) MeshWorker::DoFInfo dof_info(dofs.block_info()); // integration_loop(ITERATOR begin, - // typename identity::type end, + // std_cxx20::type_identity_t end, // DOFINFO &dinfo, // INFOBOX &info, // const std::function &dofs, MeshWorker::LoopControl &lctrl) MeshWorker::DoFInfo dof_info(dofs.block_info()); // integration_loop(ITERATOR begin, - // typename identity::type end, + // std_cxx20::type_identity_t end, // DOFINFO &dinfo, // INFOBOX &info, // const std::function void - run(const Iterator & begin, - const typename identity::type &end, - Worker worker, - Copier copier, - const ScratchData & sample_scratch_data, - const CopyData & sample_copy_data, + run(const Iterator & begin, + const std_cxx20::type_identity_t &end, + Worker worker, + Copier copier, + const ScratchData & sample_scratch_data, + const CopyData & sample_copy_data, const unsigned int queue_length = 2 * MultithreadInfo::n_threads(), const unsigned int chunk_size = 8) { @@ -115,9 +115,9 @@ namespace taskflow_v1 typename ScratchData, typename CopyData> void - run(const Iterator & begin, - const typename identity::type &end, - MainClass & main_object, + run(const Iterator & begin, + const std_cxx20::type_identity_t &end, + MainClass & main_object, void (MainClass::*worker)(const Iterator &, ScratchData &, CopyData &), void (MainClass::*copier)(const CopyData &), const ScratchData &sample_scratch_data,