From: Bruno Turcksin Date: Wed, 19 Apr 2023 14:19:21 +0000 (+0000) Subject: Prefix names used for Kokkos kernels with dealii X-Git-Tag: v9.5.0-rc1~209^2~3 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=356bfd55016a2318f54f2b187160749c84c3df31;p=dealii.git Prefix names used for Kokkos kernels with dealii --- diff --git a/include/deal.II/base/partitioner.templates.h b/include/deal.II/base/partitioner.templates.h index 9e9673bac7..df706f3292 100644 --- a/include/deal.II/base/partitioner.templates.h +++ b/include/deal.II/base/partitioner.templates.h @@ -130,7 +130,7 @@ namespace Utilities auto locally_owned_array_data = locally_owned_array.data(); MemorySpace::Default::kokkos_space::execution_space exec; Kokkos::parallel_for( - "fill temp_array_ptr", + "dealii::fill temp_array_ptr", Kokkos::RangePolicy< MemorySpace::Default::kokkos_space::execution_space>( exec, 0, chunk_size), @@ -611,7 +611,7 @@ namespace Utilities using IndexType = decltype(chunk_size); MemorySpace::Default::kokkos_space::execution_space exec; Kokkos::parallel_for( - "fill locally_owned_array, add", + "dealii::fill locally_owned_array, add", Kokkos::RangePolicy< MemorySpace::Default::kokkos_space::execution_space>( exec, 0, chunk_size), @@ -635,7 +635,7 @@ namespace Utilities using IndexType = decltype(chunk_size); MemorySpace::Default::kokkos_space::execution_space exec; Kokkos::parallel_for( - "fill locally_owned_array, min", + "dealii::fill locally_owned_array, min", Kokkos::RangePolicy< MemorySpace::Default::kokkos_space::execution_space>( exec, 0, chunk_size), @@ -662,7 +662,7 @@ namespace Utilities using IndexType = decltype(chunk_size); MemorySpace::Default::kokkos_space::execution_space exec; Kokkos::parallel_for( - "fill locally_owned_array, max", + "dealii::fill locally_owned_array, max", Kokkos::RangePolicy< MemorySpace::Default::kokkos_space::execution_space>( exec, 0, chunk_size), diff --git a/include/deal.II/lac/affine_constraints.templates.h b/include/deal.II/lac/affine_constraints.templates.h index 340bfdc64d..2705ebda8a 100644 --- a/include/deal.II/lac/affine_constraints.templates.h +++ b/include/deal.II/lac/affine_constraints.templates.h @@ -2272,7 +2272,7 @@ namespace internal ExecutionSpace exec; auto local_values = vec.get_values(); Kokkos::parallel_for( - "set_zero_parallel", + "dealii::set_zero_parallel", Kokkos::RangePolicy(exec, 0, n_constraints), KOKKOS_LAMBDA(int i) { local_values[constrained_local_dofs_device[i]] = 0; diff --git a/include/deal.II/lac/la_parallel_vector.templates.h b/include/deal.II/lac/la_parallel_vector.templates.h index 20962b80db..6bed083a67 100644 --- a/include/deal.II/lac/la_parallel_vector.templates.h +++ b/include/deal.II/lac/la_parallel_vector.templates.h @@ -387,7 +387,7 @@ namespace LinearAlgebra Kokkos::view_alloc(Kokkos::WithoutInitializing, "indices"), n_elements); Kokkos::parallel_for( - "import_elements: fill indices", + "dealii::import_elements: fill indices", Kokkos::RangePolicy(host_exec, 0, n_elements), @@ -410,7 +410,7 @@ namespace LinearAlgebra // Set the values in tmp_vector Kokkos::parallel_for( - "import_elements: set values tmp_vector", + "dealii::import_elements: set values tmp_vector", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, n_elements), @@ -426,7 +426,7 @@ namespace LinearAlgebra const size_type tmp_n_elements = tmp_index_set.n_elements(); Kokkos::realloc(indices, tmp_n_elements); Kokkos::parallel_for( - "import_elements: copy local elements to val", + "dealii::import_elements: copy local elements to val", Kokkos::RangePolicy(host_exec, 0, n_elements), @@ -443,7 +443,7 @@ namespace LinearAlgebra if (operation == VectorOperation::add) Kokkos::parallel_for( - "import_elements: add values", + "dealii::import_elements: add values", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, n_elements), @@ -452,7 +452,7 @@ namespace LinearAlgebra }); else Kokkos::parallel_for( - "import_elements: set values", + "dealii::import_elements: set values", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, n_elements), @@ -476,7 +476,7 @@ namespace LinearAlgebra typename ::dealii::MemorySpace::Default::kokkos_space::execution_space exec; Kokkos::parallel_reduce( - "linfty_norm_local", + "dealii::linfty_norm_local", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, size), diff --git a/include/deal.II/lac/precondition.h b/include/deal.II/lac/precondition.h index a568987970..a06c43365a 100644 --- a/include/deal.II/lac/precondition.h +++ b/include/deal.II/lac/precondition.h @@ -3384,7 +3384,7 @@ namespace internal Kokkos::IndexType> policy(0, n_local_elements); Kokkos::parallel_for( - "PreconditionChebyshev::set_initial_guess", + "dealii::PreconditionChebyshev::set_initial_guess", policy, KOKKOS_LAMBDA(types::global_dof_index i) { values_ptr[i] = (i + first_local_range) % 11; diff --git a/include/deal.II/lac/vector_operations_internal.h b/include/deal.II/lac/vector_operations_internal.h index 291d05f56b..09a128292a 100644 --- a/include/deal.II/lac/vector_operations_internal.h +++ b/include/deal.II/lac/vector_operations_internal.h @@ -2168,7 +2168,7 @@ namespace internal auto exec = typename ::dealii::MemorySpace::Default::kokkos_space:: execution_space{}; Kokkos::parallel_for( - "add_vector", + "dealii::add_vector", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, size), @@ -2189,7 +2189,7 @@ namespace internal auto exec = typename ::dealii::MemorySpace::Default::kokkos_space:: execution_space{}; Kokkos::parallel_for( - "subtract_vector", + "dealii::subtract_vector", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, size), @@ -2209,7 +2209,7 @@ namespace internal auto exec = typename ::dealii::MemorySpace::Default::kokkos_space:: execution_space{}; Kokkos::parallel_for( - "add_factor", + "dealii::add_factor", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, size), @@ -2231,7 +2231,7 @@ namespace internal auto exec = typename ::dealii::MemorySpace::Default::kokkos_space:: execution_space{}; Kokkos::parallel_for( - "add_av", + "dealii::add_av", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, size), @@ -2258,7 +2258,7 @@ namespace internal auto exec = typename ::dealii::MemorySpace::Default::kokkos_space:: execution_space{}; Kokkos::parallel_for( - "add_avpbw", + "dealii::add_avpbw", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, size), @@ -2282,7 +2282,7 @@ namespace internal auto exec = typename ::dealii::MemorySpace::Default::kokkos_space:: execution_space{}; Kokkos::parallel_for( - "sadd_xv", + "dealii::sadd_xv", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, size), @@ -2307,7 +2307,7 @@ namespace internal auto exec = typename ::dealii::MemorySpace::Default::kokkos_space:: execution_space{}; Kokkos::parallel_for( - "sadd_xav", + "dealii::sadd_xav", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, size), @@ -2335,7 +2335,7 @@ namespace internal auto exec = typename ::dealii::MemorySpace::Default::kokkos_space:: execution_space{}; Kokkos::parallel_for( - "sadd_xavbw", + "dealii::sadd_xavbw", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, size), @@ -2358,7 +2358,7 @@ namespace internal auto exec = typename ::dealii::MemorySpace::Default::kokkos_space:: execution_space{}; Kokkos::parallel_for( - "multiply_factor", + "dealii::multiply_factor", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, size), @@ -2379,7 +2379,7 @@ namespace internal auto exec = typename ::dealii::MemorySpace::Default::kokkos_space:: execution_space{}; Kokkos::parallel_for( - "scale", + "dealii::scale", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, size), @@ -2401,7 +2401,7 @@ namespace internal auto exec = typename ::dealii::MemorySpace::Default::kokkos_space:: execution_space{}; Kokkos::parallel_for( - "equ_au", + "dealii::equ_au", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, size), @@ -2428,7 +2428,7 @@ namespace internal auto exec = typename ::dealii::MemorySpace::Default::kokkos_space:: execution_space{}; Kokkos::parallel_for( - "equ_aubv", + "dealii::equ_aubv", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, size), @@ -2452,7 +2452,7 @@ namespace internal auto exec = typename ::dealii::MemorySpace::Default::kokkos_space:: execution_space{}; Kokkos::parallel_reduce( - "dot", + "dealii::dot", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, size), @@ -2489,7 +2489,7 @@ namespace internal auto exec = typename ::dealii::MemorySpace::Default::kokkos_space:: execution_space{}; Kokkos::parallel_reduce( - "mean_value", + "dealii::mean_value", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, size), @@ -2515,7 +2515,7 @@ namespace internal auto exec = typename ::dealii::MemorySpace::Default::kokkos_space:: execution_space{}; Kokkos::parallel_reduce( - "norm_1", + "dealii::norm_1", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, size), @@ -2545,7 +2545,7 @@ namespace internal auto exec = typename ::dealii::MemorySpace::Default::kokkos_space:: execution_space{}; Kokkos::parallel_reduce( - "norm_p", + "dealii::norm_p", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, size), @@ -2580,7 +2580,7 @@ namespace internal auto exec = typename ::dealii::MemorySpace::Default::kokkos_space:: execution_space{}; Kokkos::parallel_reduce( - "add_and_dot", + "dealii::add_and_dot", Kokkos::RangePolicy< ::dealii::MemorySpace::Default::kokkos_space::execution_space>( exec, 0, size), diff --git a/include/deal.II/matrix_free/cuda_matrix_free.templates.h b/include/deal.II/matrix_free/cuda_matrix_free.templates.h index a9c7716c54..656b73cecf 100644 --- a/include/deal.II/matrix_free/cuda_matrix_free.templates.h +++ b/include/deal.II/matrix_free/cuda_matrix_free.templates.h @@ -580,7 +580,7 @@ namespace CUDAWrappers const Number * src_ptr = src.get_values(); Number * dst_ptr = dst.get_values(); Kokkos::parallel_for( - "copy_constrained_values", + "dealii::copy_constrained_values", Kokkos::RangePolicy( 0, n_constrained_dofs), KOKKOS_LAMBDA(int dof) { @@ -614,7 +614,7 @@ namespace CUDAWrappers const unsigned int size = partitioner ? dst.locally_owned_size() : dst.size(); Kokkos::parallel_for( - "set_constrained_values", + "dealii::set_constrained_values", Kokkos::RangePolicy( 0, n_constrained_dofs), KOKKOS_LAMBDA(int dof) {