Reference documentation for deal.II version 9.5.0
\(\newcommand{\dealvcentcolon}{\mathrel{\mathop{:}}}\) \(\newcommand{\dealcoloneq}{\dealvcentcolon\mathrel{\mkern-1.2mu}=}\) \(\newcommand{\jump}[1]{\left[\!\left[ #1 \right]\!\right]}\) \(\newcommand{\average}[1]{\left\{\!\left\{ #1 \right\}\!\right\}}\)
Loading...
Searching...
No Matches
Classes | Public Types | Public Member Functions | Private Attributes | List of all members
CUDAWrappers::PreconditionILU< Number > Class Template Reference

#include <deal.II/lac/cuda_precondition.h>

Classes

struct  AdditionalData
 

Public Types

using size_type = int
 

Public Member Functions

 PreconditionILU (const Utilities::CUDA::Handle &handle)
 
 PreconditionILU (const PreconditionILU< Number > &)=delete
 
PreconditionILUoperator= (const PreconditionILU< Number > &)=delete
 
 ~PreconditionILU ()
 
void initialize (const SparseMatrix< Number > &matrix, const AdditionalData &additional_data=AdditionalData())
 
void vmult (LinearAlgebra::CUDAWrappers::Vector< Number > &dst, const LinearAlgebra::CUDAWrappers::Vector< Number > &src) const
 
void Tvmult (LinearAlgebra::CUDAWrappers::Vector< Number > &dst, const LinearAlgebra::CUDAWrappers::Vector< Number > &src) const
 
size_type m () const
 
size_type n () const
 

Private Attributes

cusparseHandle_t cusparse_handle
 
cusparseMatDescr_t descr_M
 
cusparseMatDescr_t descr_L
 
cusparseMatDescr_t descr_U
 
csrilu02Info_t info_M
 
csrsv2Info_t info_L
 
csrsv2Info_t info_U
 
SmartPointer< const SparseMatrix< Number > > matrix_pointer
 
std::unique_ptr< Number[], void(*)(Number *)> P_val_dev
 
const intP_row_ptr_dev
 
const intP_column_index_dev
 
std::unique_ptr< Number[], void(*)(Number *)> tmp_dev
 
std::unique_ptr< void, void(*)(void *)> buffer_dev
 
cusparseSolvePolicy_t policy_L
 
cusparseSolvePolicy_t policy_U
 
cusparseSolvePolicy_t policy_M
 
int n_rows
 
int n_nonzero_elements
 

Detailed Description

template<typename Number>
class CUDAWrappers::PreconditionILU< Number >

This class implements an incomplete LU factorization preconditioner for CUDAWrappers::SparseMatrix matrices.

The implementation closely follows the one documented in the cuSPARSE documentation (https://docs.nvidia.com/cuda/cusparse/index.html#cusparse-lt-t-gt-csrilu02).

Note
Instantiations for this template are provided for <float> and <double>.

Definition at line 275 of file cuda_precondition.h.

Member Typedef Documentation

◆ size_type

template<typename Number >
using CUDAWrappers::PreconditionILU< Number >::size_type = int

Declare the type for container size.

Definition at line 281 of file cuda_precondition.h.

Constructor & Destructor Documentation

◆ PreconditionILU() [1/2]

template<typename Number >
CUDAWrappers::PreconditionILU< Number >::PreconditionILU ( const Utilities::CUDA::Handle handle)

Constructor.

Definition at line 1504 of file cuda_precondition.cc.

◆ PreconditionILU() [2/2]

template<typename Number >
CUDAWrappers::PreconditionILU< Number >::PreconditionILU ( const PreconditionILU< Number > &  )
delete

The copy constructor is deleted.

◆ ~PreconditionILU()

template<typename Number >
CUDAWrappers::PreconditionILU< Number >::~PreconditionILU

Destructor. Free all resources that were initialized in this class.

Definition at line 1568 of file cuda_precondition.cc.

Member Function Documentation

◆ operator=()

template<typename Number >
PreconditionILU & CUDAWrappers::PreconditionILU< Number >::operator= ( const PreconditionILU< Number > &  )
delete

The copy assignment operator is deleted.

◆ initialize()

template<typename Number >
void CUDAWrappers::PreconditionILU< Number >::initialize ( const SparseMatrix< Number > &  matrix,
const AdditionalData additional_data = AdditionalData() 
)

Initialize this object. In particular, the given matrix is copied to be modified in-place. For the underlying sparsity pattern pointers are stored. Specifically, this means that the current object can only be used reliably as long as matrix is valid and has not been changed since calling this function.

The additional_data determines if level information are used.

Definition at line 1594 of file cuda_precondition.cc.

◆ vmult()

template<typename Number >
void CUDAWrappers::PreconditionILU< Number >::vmult ( LinearAlgebra::CUDAWrappers::Vector< Number > &  dst,
const LinearAlgebra::CUDAWrappers::Vector< Number > &  src 
) const

Apply the preconditioner.

Definition at line 1752 of file cuda_precondition.cc.

◆ Tvmult()

template<typename Number >
void CUDAWrappers::PreconditionILU< Number >::Tvmult ( LinearAlgebra::CUDAWrappers::Vector< Number > &  dst,
const LinearAlgebra::CUDAWrappers::Vector< Number > &  src 
) const

Apply the transposed preconditioner. Not yet implemented.

Definition at line 1807 of file cuda_precondition.cc.

◆ m()

template<typename Number >
size_type CUDAWrappers::PreconditionILU< Number >::m ( ) const

Return the dimension of the codomain (or range) space. Note that the matrix is square and has dimension \(m \times m\).

Note
This function should only be called if the preconditioner has been initialized.

◆ n()

template<typename Number >
size_type CUDAWrappers::PreconditionILU< Number >::n ( ) const

Return the dimension of the codomain (or range) space. Note that the matrix is square and has dimension \(n \times n\).

Note
This function should only be called if the preconditioner has been initialized.

Member Data Documentation

◆ cusparse_handle

template<typename Number >
cusparseHandle_t CUDAWrappers::PreconditionILU< Number >::cusparse_handle
private

cuSPARSE handle used to call cuSPARSE functions.

Definition at line 378 of file cuda_precondition.h.

◆ descr_M

template<typename Number >
cusparseMatDescr_t CUDAWrappers::PreconditionILU< Number >::descr_M
private

cuSPARSE description of the sparse matrix \(M=LU\).

Definition at line 383 of file cuda_precondition.h.

◆ descr_L

template<typename Number >
cusparseMatDescr_t CUDAWrappers::PreconditionILU< Number >::descr_L
private

cuSPARSE description of the lower triangular matrix \(L\).

Definition at line 388 of file cuda_precondition.h.

◆ descr_U

template<typename Number >
cusparseMatDescr_t CUDAWrappers::PreconditionILU< Number >::descr_U
private

cuSPARSE description of the upper triangular matrix \(U\).

Definition at line 393 of file cuda_precondition.h.

◆ info_M

template<typename Number >
csrilu02Info_t CUDAWrappers::PreconditionILU< Number >::info_M
private

Solve and analysis structure for \(M=LU\).

Definition at line 398 of file cuda_precondition.h.

◆ info_L

template<typename Number >
csrsv2Info_t CUDAWrappers::PreconditionILU< Number >::info_L
private

Solve and analysis structure for the lower triangular matrix \(L\).

Definition at line 403 of file cuda_precondition.h.

◆ info_U

template<typename Number >
csrsv2Info_t CUDAWrappers::PreconditionILU< Number >::info_U
private

Solve and analysis structure for the upper triangular matrix \(U\).

Definition at line 408 of file cuda_precondition.h.

◆ matrix_pointer

template<typename Number >
SmartPointer<const SparseMatrix<Number> > CUDAWrappers::PreconditionILU< Number >::matrix_pointer
private

Pointer to the matrix this object was initialized with.

Definition at line 413 of file cuda_precondition.h.

◆ P_val_dev

template<typename Number >
std::unique_ptr<Number[], void (*)(Number *)> CUDAWrappers::PreconditionILU< Number >::P_val_dev
private

Pointer to the values (on the device) of the computed preconditioning matrix.

Definition at line 419 of file cuda_precondition.h.

◆ P_row_ptr_dev

template<typename Number >
const int* CUDAWrappers::PreconditionILU< Number >::P_row_ptr_dev
private

Pointer to the row pointer (on the device) of the sparse matrix this object was initialized with. Guarded by matrix_pointer.

Definition at line 425 of file cuda_precondition.h.

◆ P_column_index_dev

template<typename Number >
const int* CUDAWrappers::PreconditionILU< Number >::P_column_index_dev
private

Pointer to the column indices (on the device) of the sparse matrix this object was initialized with. Guarded by matrix_pointer.

Definition at line 431 of file cuda_precondition.h.

◆ tmp_dev

template<typename Number >
std::unique_ptr<Number[], void (*)(Number *)> CUDAWrappers::PreconditionILU< Number >::tmp_dev
private

Pointer to the value (on the device) for a temporary (helper) vector used in vmult().

Definition at line 437 of file cuda_precondition.h.

◆ buffer_dev

template<typename Number >
std::unique_ptr<void, void (*)(void *)> CUDAWrappers::PreconditionILU< Number >::buffer_dev
private

Pointer to an internal buffer (on the device) that is used for computing the decomposition.

Definition at line 443 of file cuda_precondition.h.

◆ policy_L

template<typename Number >
cusparseSolvePolicy_t CUDAWrappers::PreconditionILU< Number >::policy_L
private

Determine if level information should be generated for the lower triangular matrix \(L\). This value can be modified through an AdditionalData object.

Definition at line 450 of file cuda_precondition.h.

◆ policy_U

template<typename Number >
cusparseSolvePolicy_t CUDAWrappers::PreconditionILU< Number >::policy_U
private

Determine if level information should be generated for the upper triangular matrix \(U\). This value can be modified through an AdditionalData object.

Definition at line 457 of file cuda_precondition.h.

◆ policy_M

template<typename Number >
cusparseSolvePolicy_t CUDAWrappers::PreconditionILU< Number >::policy_M
private

Determine if level information should be generated for \(M=LU\). This value can be modified through an AdditionalData object.

Definition at line 463 of file cuda_precondition.h.

◆ n_rows

template<typename Number >
int CUDAWrappers::PreconditionILU< Number >::n_rows
private

The number of rows is the same as for the matrix this object has been initialized with.

Definition at line 469 of file cuda_precondition.h.

◆ n_nonzero_elements

template<typename Number >
int CUDAWrappers::PreconditionILU< Number >::n_nonzero_elements
private

The number of non-zero elements is the same as for the matrix this object has been initialized with.

Definition at line 475 of file cuda_precondition.h.


The documentation for this class was generated from the following files: