Reference documentation for deal.II version 9.6.0
|
This is the complete list of members for IndexSet, including all inherited members.
add_index(const size_type index) | IndexSet | inline |
add_indices(const ForwardIterator &begin, const ForwardIterator &end) | IndexSet | inline |
add_indices(const IndexSet &other, const size_type offset=0) | IndexSet | |
add_range(const size_type begin, const size_type end) | IndexSet | inline |
add_range_lower_bound(const Range &range) | IndexSet | private |
add_ranges_internal(boost::container::small_vector< std::pair< size_type, size_type >, 200 > &tmp_ranges, const bool ranges_are_sorted) | IndexSet | private |
at(const size_type global_index) const | IndexSet | |
begin() const | IndexSet | inline |
begin_intervals() const | IndexSet | inline |
block_read(std::istream &in) | IndexSet | |
block_write(std::ostream &out) const | IndexSet | |
clear() | IndexSet | inline |
complete_index_set(const IndexSet::size_type N) | IndexSet | related |
compress() const | IndexSet | inline |
compress_mutex | IndexSet | mutableprivate |
do_compress() const | IndexSet | private |
end() const | IndexSet | inline |
end_intervals() const | IndexSet | inline |
ExcIndexNotPresent(size_type arg1) | IndexSet | static |
fill_binary_vector(VectorType &vector) const | IndexSet | |
fill_binary_vector(Vector &vector) const | IndexSet | |
fill_index_vector(std::vector< size_type > &indices) const | IndexSet | |
get_index_vector() const | IndexSet | |
get_view(const size_type begin, const size_type end) const | IndexSet | |
get_view(const IndexSet &mask) const | IndexSet | |
index_space_size | IndexSet | private |
index_within_set(const size_type global_index) const | IndexSet | inline |
index_within_set_binary_search(const size_type global_index) const | IndexSet | private |
IndexSet() | IndexSet | inline |
IndexSet(const size_type size) | IndexSet | inlineexplicit |
IndexSet(const IndexSet &)=default | IndexSet | |
IndexSet(IndexSet &&is) noexcept | IndexSet | inline |
IndexSet(const Teuchos::RCP< const Tpetra::Map< int, types::signed_global_dof_index, NodeType > > &map) | IndexSet | explicit |
IndexSet(const Epetra_BlockMap &map) | IndexSet | explicit |
is_ascending_and_one_to_one(const MPI_Comm communicator) const | IndexSet | |
is_compressed | IndexSet | mutableprivate |
is_contiguous() const | IndexSet | inline |
is_element(const size_type index) const | IndexSet | inline |
is_element_binary_search(const size_type local_index) const | IndexSet | private |
is_empty() const | IndexSet | inline |
is_subset_of(const IndexSet &other) const | IndexSet | |
largest_range | IndexSet | mutableprivate |
largest_range_starting_index() const | IndexSet | inline |
make_petsc_is(const MPI_Comm communicator=MPI_COMM_WORLD) const | IndexSet | |
make_tpetra_map(const MPI_Comm communicator=MPI_COMM_WORLD, const bool overlapping=false) const | IndexSet | |
make_tpetra_map_rcp(const MPI_Comm communicator=MPI_COMM_WORLD, const bool overlapping=false) const | IndexSet | |
make_trilinos_map(const MPI_Comm communicator=MPI_COMM_WORLD, const bool overlapping=false) const | IndexSet | |
memory_consumption() const | IndexSet | |
n_elements() const | IndexSet | inline |
n_intervals() const | IndexSet | inline |
nth_index_in_set(const size_type local_index) const | IndexSet | inline |
nth_index_in_set_binary_search(const size_type local_index) const | IndexSet | private |
operator!=(const IndexSet &is) const | IndexSet | inline |
operator&(const IndexSet &is) const | IndexSet | |
operator=(const IndexSet &)=default | IndexSet | |
operator=(IndexSet &&is) noexcept | IndexSet | inline |
operator==(const IndexSet &is) const | IndexSet | inline |
pop_back() | IndexSet | |
pop_front() | IndexSet | |
print(StreamType &out) const | IndexSet | inline |
ranges | IndexSet | mutableprivate |
read(std::istream &in) | IndexSet | |
serialize(Archive &ar, const unsigned int version) | IndexSet | inline |
set_size(const size_type size) | IndexSet | inline |
size() const | IndexSet | inline |
size_type typedef | IndexSet | |
split_by_block(const std::vector< types::global_dof_index > &n_indices_per_block) const | IndexSet | |
subtract_set(const IndexSet &other) | IndexSet | |
tensor_product(const IndexSet &other) const | IndexSet | |
value_type typedef | IndexSet | |
write(std::ostream &out) const | IndexSet |