MueLu  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse > Class Template Reference

#include <MueLu_MatrixConstruction.hpp>

Public Member Functions

 VectorFillFunctor (local_matrix_type &A_, local_ordinal_type blockSize_, block_indices_view_type ghosted_point_to_block_, results_view &results_, local_matrix_type &filteredA_, local_graph_type &graph_, magnitudeType dirichletThreshold_)
 
KOKKOS_INLINE_FUNCTION void operator() (const local_ordinal_type brlid) const
 

Private Types

using scalar_type = typename local_matrix_type::value_type
 
using local_ordinal_type = typename local_matrix_type::ordinal_type
 
using local_graph_type = typename local_matrix_type::staticcrsgraph_type
 
using memory_space = typename local_matrix_type::memory_space
 
using results_view = Kokkos::View< DecisionType *, memory_space >
 
using ATS = Kokkos::ArithTraits< scalar_type >
 
using OTS = Kokkos::ArithTraits< local_ordinal_type >
 
using block_indices_view_type = Kokkos::View< local_ordinal_type *, memory_space >
 
using permutation_type = Kokkos::View< local_ordinal_type *, memory_space >
 
using magnitudeType = typename ATS::magnitudeType
 

Private Attributes

local_matrix_type A
 
local_ordinal_type blockSize
 
block_indices_view_type ghosted_point_to_block
 
results_view results
 
local_matrix_type filteredA
 
local_graph_type graph
 
magnitudeType dirichletThreshold
 
const scalar_type zero = ATS::zero()
 
const scalar_type one = ATS::one()
 
BlockRowComparison
< local_matrix_type > 
comparison
 
permutation_type permutation
 

Detailed Description

template<class local_matrix_type, bool lumping, bool reuse>
class MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >

Definition at line 789 of file MueLu_MatrixConstruction.hpp.

Member Typedef Documentation

template<class local_matrix_type, bool lumping, bool reuse>
using MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::scalar_type = typename local_matrix_type::value_type
private

Definition at line 791 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
using MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::local_ordinal_type = typename local_matrix_type::ordinal_type
private

Definition at line 792 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
using MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::local_graph_type = typename local_matrix_type::staticcrsgraph_type
private

Definition at line 793 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
using MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::memory_space = typename local_matrix_type::memory_space
private

Definition at line 794 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
using MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::results_view = Kokkos::View<DecisionType*, memory_space>
private

Definition at line 795 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
using MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::ATS = Kokkos::ArithTraits<scalar_type>
private

Definition at line 796 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
using MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::OTS = Kokkos::ArithTraits<local_ordinal_type>
private

Definition at line 797 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
using MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::block_indices_view_type = Kokkos::View<local_ordinal_type*, memory_space>
private

Definition at line 798 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
using MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::permutation_type = Kokkos::View<local_ordinal_type*, memory_space>
private

Definition at line 799 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
using MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::magnitudeType = typename ATS::magnitudeType
private

Definition at line 800 of file MueLu_MatrixConstruction.hpp.

Constructor & Destructor Documentation

template<class local_matrix_type, bool lumping, bool reuse>
MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::VectorFillFunctor ( local_matrix_type &  A_,
local_ordinal_type  blockSize_,
block_indices_view_type  ghosted_point_to_block_,
results_view results_,
local_matrix_type &  filteredA_,
local_graph_type graph_,
magnitudeType  dirichletThreshold_ 
)
inline

Definition at line 816 of file MueLu_MatrixConstruction.hpp.

Member Function Documentation

template<class local_matrix_type, bool lumping, bool reuse>
KOKKOS_INLINE_FUNCTION void MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::operator() ( const local_ordinal_type  brlid) const
inline

Definition at line 829 of file MueLu_MatrixConstruction.hpp.

Member Data Documentation

template<class local_matrix_type, bool lumping, bool reuse>
local_matrix_type MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::A
private

Definition at line 802 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
local_ordinal_type MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::blockSize
private

Definition at line 803 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
block_indices_view_type MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::ghosted_point_to_block
private

Definition at line 804 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
results_view MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::results
private

Definition at line 805 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
local_matrix_type MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::filteredA
private

Definition at line 806 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
local_graph_type MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::graph
private

Definition at line 807 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
magnitudeType MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::dirichletThreshold
private

Definition at line 808 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
const scalar_type MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::zero = ATS::zero()
private

Definition at line 809 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
const scalar_type MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::one = ATS::one()
private

Definition at line 810 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
BlockRowComparison<local_matrix_type> MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::comparison
private

Definition at line 812 of file MueLu_MatrixConstruction.hpp.

template<class local_matrix_type, bool lumping, bool reuse>
permutation_type MueLu::MatrixConstruction::VectorFillFunctor< local_matrix_type, lumping, reuse >::permutation
private

Definition at line 813 of file MueLu_MatrixConstruction.hpp.


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