]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove unused variables
authorBruno Turcksin <bruno.turcksin@gmail.com>
Wed, 22 Mar 2023 13:53:11 +0000 (09:53 -0400)
committerBruno Turcksin <bruno.turcksin@gmail.com>
Thu, 6 Apr 2023 13:15:22 +0000 (13:15 +0000)
include/deal.II/matrix_free/cuda_matrix_free.h
include/deal.II/matrix_free/cuda_matrix_free.templates.h

index 80c5218aecfa1f2033d4de14a8611be2ccc8f6df..ee3bf029417afe9a2c580abd7408cc1d7e5747f1 100644 (file)
@@ -103,17 +103,6 @@ namespace CUDAWrappers
     using CellFilter =
       FilteredIterator<typename DoFHandler<dim>::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.
      */
index f39594ed3963de751b86455bbd940871a854f417..b094559789972709d91183a0fe464ba3b22aa9ce 100644 (file)
@@ -134,67 +134,6 @@ namespace CUDAWrappers
       return global_co_shape_gradients_f[i];
     }
 
-    template <typename Number>
-    using CUDAVector = ::dealii::LinearAlgebra::CUDAWrappers::Vector<Number>;
-
-    /**
-     * 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 <typename Number>
-    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 <typename Number>
-    void
-    transpose_in_place(std::vector<Number> &array_host,
-                       const unsigned int   n,
-                       const unsigned int   m)
-    {
-      // convert to structure-of-array
-      std::vector<Number> 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 <typename Number1>
-    void
-    alloc_and_copy(Number1 **array_device,
-                   const ArrayView<const Number1, MemorySpace::Host> 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);
-    }
-
 
 
     /**

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.