From 69cf26fd83aa92117c511b4b37805da0ed29bf0f Mon Sep 17 00:00:00 2001 From: Bruno Turcksin Date: Wed, 22 Mar 2023 09:53:11 -0400 Subject: [PATCH] Remove unused variables --- .../deal.II/matrix_free/cuda_matrix_free.h | 11 ---- .../matrix_free/cuda_matrix_free.templates.h | 61 ------------------- 2 files changed, 72 deletions(-) diff --git a/include/deal.II/matrix_free/cuda_matrix_free.h b/include/deal.II/matrix_free/cuda_matrix_free.h index 80c5218aec..ee3bf02941 100644 --- a/include/deal.II/matrix_free/cuda_matrix_free.h +++ b/include/deal.II/matrix_free/cuda_matrix_free.h @@ -103,17 +103,6 @@ namespace CUDAWrappers using CellFilter = FilteredIterator::active_cell_iterator>; - /** - * Parallelization scheme used: parallel_in_elem (parallelism at the level - * of degrees of freedom) or parallel_over_elem (parallelism at the level of - * cells) - */ - enum ParallelizationScheme - { - parallel_in_elem, - parallel_over_elem - }; - /** * Standardized data struct to pipe additional data to MatrixFree. */ 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 f39594ed39..b094559789 100644 --- a/include/deal.II/matrix_free/cuda_matrix_free.templates.h +++ b/include/deal.II/matrix_free/cuda_matrix_free.templates.h @@ -134,67 +134,6 @@ namespace CUDAWrappers return global_co_shape_gradients_f[i]; } - template - using CUDAVector = ::dealii::LinearAlgebra::CUDAWrappers::Vector; - - /** - * Transpose a N x M matrix stored in a one-dimensional array to a M x N - * matrix stored in a one-dimensional array. - */ - template - void - transpose(const unsigned int N, - const unsigned M, - const Number * src, - Number * dst) - { - // src is N X M - // dst is M X N - for (unsigned int i = 0; i < N; ++i) - for (unsigned int j = 0; j < M; ++j) - dst[j * N + i] = src[i * M + j]; - } - - - - /** - * Same as above but the source and the destination are the same vector. - */ - template - void - transpose_in_place(std::vector &array_host, - const unsigned int n, - const unsigned int m) - { - // convert to structure-of-array - std::vector old(array_host.size()); - old.swap(array_host); - - transpose(n, m, old.data(), array_host.data()); - } - - - - /** - * Allocate an array on the @ref GlossDevice "device" and copy @p array_host to the @ref GlossDevice "device". - */ - template - void - alloc_and_copy(Number1 **array_device, - const ArrayView array_host, - const unsigned int n) - { - cudaError_t error_code = cudaMalloc(array_device, n * sizeof(Number1)); - AssertCuda(error_code); - AssertDimension(array_host.size(), n); - - error_code = cudaMemcpy(*array_device, - array_host.data(), - n * sizeof(Number1), - cudaMemcpyHostToDevice); - AssertCuda(error_code); - } - /** -- 2.39.5