![]() |
Reference documentation for deal.II version Git 292c2606a1 2021-03-03 00:48:14 +0100
|
Namespaces | |
internal | |
Classes | |
struct | DataHost |
class | FEEvaluation |
class | MatrixFree |
class | PreconditionIC |
class | PreconditionILU |
struct | SharedData |
class | SolverDirect |
class | SparseMatrix |
Functions | |
__host__ constexpr unsigned int | cells_per_block_shmem (int dim, int fe_degree) |
Variables | |
constexpr int | block_size = 512 |
constexpr int | chunk_size = 1 |
constexpr int | warp_size = 32 |
constexpr unsigned int | mf_max_elem_degree = 10 |
constexpr unsigned int | mf_n_concurrent_objects = 5 |
Namespace for the CUDA wrappers
Definition at line 693 of file cuda_matrix_free.h.
constexpr int CUDAWrappers::block_size = 512 |
Define the size of a block when launching a CUDA kernel. This number can be changed depending on the architecture the code is running on.
Definition at line 29 of file cuda_size.h.
constexpr int CUDAWrappers::chunk_size = 1 |
Define the size of chunk of data worked on by a thread. This number can be changed depending on the architecture the code is running on.
Definition at line 35 of file cuda_size.h.
constexpr int CUDAWrappers::warp_size = 32 |
Define the number of threads in a warp.
Definition at line 40 of file cuda_size.h.
constexpr unsigned int CUDAWrappers::mf_max_elem_degree = 10 |
Define the largest finite element degree that can be solved using CUDAWrappers::MatrixFree. Changing this number will affect the amount of constant memory being used.
Definition at line 47 of file cuda_size.h.
constexpr unsigned int CUDAWrappers::mf_n_concurrent_objects = 5 |
Define the maximum number of valid CUDAWrappers::MatrixFree object. Changing this number will affect the amount of constant memory being used.
Definition at line 53 of file cuda_size.h.