Reference documentation for deal.II version 9.1.1
|
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 unsigned int offset=0) | IndexSet | |
add_range(const size_type begin, const size_type end) | IndexSet | |
at(const size_type global_index) const | IndexSet | inline |
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 unsigned int 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_index_vector(std::vector< size_type > &indices) const | IndexSet | |
get_view(const size_type begin, const size_type end) const | IndexSet | |
index_space_size | IndexSet | private |
index_within_set(const size_type global_index) const | IndexSet | inline |
IndexSet() | IndexSet | inline |
IndexSet(const size_type size) | IndexSet | inlineexplicit |
IndexSet(const IndexSet &)=default | IndexSet | |
IndexSet(IndexSet &&is) noexcept | IndexSet | inline |
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_empty() const | IndexSet | inline |
largest_range | IndexSet | mutableprivate |
largest_range_starting_index() const | IndexSet | inline |
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 unsigned int local_index) const | IndexSet | inline |
operator &(const IndexSet &is) const | IndexSet | |
operator!=(const IndexSet &is) const | IndexSet | inline |
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 | |
subtract_set(const IndexSet &other) | IndexSet | |
value_type typedef | IndexSet | |
write(std::ostream &out) const | IndexSet |