32 template <
typename ForwardIterator>
36 const bool indices_are_sorted)
44 if (indices_are_sorted ==
true && n_elements > 3)
52 for (; test1 !=
end; ++test, ++test1)
67 ForwardIterator my_it =
begin;
69 std::vector<size_type>::iterator it =
106 std::vector<size_type>::iterator it2 = it + (
end - my_it);
115 else if (*my_it == *it2)
142 ForwardIterator my_it =
begin;
146 if (stop_size >
entries.capacity())
150 std::vector<size_type>::iterator it, it2;
183 for (; my_it !=
end; ++my_it)
218 return entries.capacity() *
sizeof(
size_type) +
sizeof(
Line);
232 , have_entries(false)
238 "This constructor can only be called if the provided argument "
239 "is the sparsity pattern for an empty matrix. This constructor can "
240 "not be used to copy-construct a non-empty sparsity pattern."));
249 , have_entries(false)
258 , have_entries(false)
267 , have_entries(false)
281 "This operator can only be called if the provided argument "
282 "is the sparsity pattern for an empty matrix. This operator can "
283 "not be used to copy a non-empty sparsity pattern."));
286 ExcMessage(
"This operator can only be called if the current object is "
305 "The IndexSet argument to this function needs to either "
306 "be empty (indicating the complete set of rows), or have size "
307 "equal to the desired number of rows as specified by the "
308 "first argument to this function. (Of course, the number "
309 "of indices in this IndexSet may be less than the number "
310 "of rows, but the *size* of the IndexSet must be equal.)"));
314 lines.swap(new_lines);
328 return ((
rows == 0) && (
cols == 0));
340 for (
const auto &line :
lines)
354 const bool indices_are_sorted)
369 "The row IndexSet does not contain the index i. This sparsity pattern "
370 "object cannot know whether the entry (i, j) exists or not."));
383 return std::binary_search(
lines[rowindex].entries.begin(),
384 lines[rowindex].entries.end(),
410 if (rowindex != row_entry)
411 add(row_entry, rowindex);
431 lines[rowindex].entries = std::vector<size_type>();
440 view.
reinit(
rows.n_elements(), this->n_cols());
445 for (
auto it =
rows.begin(); it !=
end; ++it, ++view_row)
450 view.
lines[view_row].entries =
lines[rowindex].entries;
458 template <
typename SparsityPatternTypeLeft,
typename SparsityPatternTypeRight>
461 const SparsityPatternTypeLeft & sp_A,
462 const SparsityPatternTypeRight &sp_B)
464 Assert(sp_A.n_rows() == sp_B.n_rows(),
467 this->
reinit(sp_A.n_cols(), sp_B.n_cols());
474 std::vector<size_type> new_cols;
475 new_cols.reserve(sp_B.max_entries_per_row());
478 for (
size_type i = 0; i < sp_A.n_rows(); ++i)
481 new_cols.resize(sp_B.row_length(i));
483 const auto last_il = sp_B.end(i);
484 auto * col_ptr = new_cols.data();
485 for (
auto il = sp_B.begin(i); il != last_il; ++il)
486 *col_ptr++ = il->column();
488 std::sort(new_cols.begin(), new_cols.end());
491 const auto last_ik = sp_A.end(i);
492 for (
auto ik = sp_A.begin(i); ik != last_ik; ++ik)
493 this->
add_entries(ik->column(), new_cols.begin(), new_cols.end(),
true);
499 template <
typename SparsityPatternTypeLeft,
typename SparsityPatternTypeRight>
502 const SparsityPatternTypeLeft & left,
503 const SparsityPatternTypeRight &right)
505 Assert(left.n_cols() == right.n_rows(),
508 this->
reinit(left.n_rows(), right.n_cols());
510 typename SparsityPatternTypeLeft::iterator it_left = left.begin(),
511 end_left = left.end();
512 for (; it_left != end_left; ++it_left)
514 const unsigned int j = it_left->column();
520 typename SparsityPatternTypeRight::iterator it_right = right.begin(j),
521 end_right = right.end(j);
522 for (; it_right != end_right; ++it_right)
523 this->
add(it_left->row(), it_right->column());
536 for (
const auto entry :
lines[row].entries)
539 out <<
']' << std::endl;
555 for (
const auto entry :
lines[row].entries)
561 out << entry <<
" " << -
static_cast<signed int>(rowindex) << std::endl;
579 for (
const auto entry :
lines[row].entries)
581 std::abs(
static_cast<int>(rowindex - entry))) >
b)
582 b = std::abs(
static_cast<signed int>(rowindex - entry));
597 for (
const auto &line :
lines)
599 n += line.entries.size();
610 std::set<types::global_dof_index>
cols;
611 for (
const auto &line :
lines)
612 cols.insert(line.entries.begin(), line.entries.end());
627 std::vector<types::global_dof_index>
rows;
628 auto line =
lines.begin();
630 for (
const auto row : locally_stored_rows)
632 if (line->entries.size() > 0)
652 for (
const auto &line :
lines)
674 const auto &
cols =
lines[local_row].entries;
677 if ((it !=
cols.end()) && (*it == col))
678 return (it -
cols.begin());
692 #ifndef DEAL_II_VECTOR_ITERATOR_IS_POINTER
695 std::vector<size_type>::iterator,
699 std::vector<size_type>::const_iterator,
700 std::vector<size_type>::const_iterator,
IndexSet nonempty_cols() const
DynamicSparsityPattern get_view(const IndexSet &rows) const
types::global_dof_index size_type
size_type memory_consumption() const
void compute_mmult_pattern(const SparsityPatternTypeLeft &left, const SparsityPatternTypeRight &right)
virtual void add_row_entries(const size_type &row, const ArrayView< const size_type > &columns, const bool indices_are_sorted=false) override
size_type column_index(const size_type row, const size_type col) const
DynamicSparsityPattern & operator=(const DynamicSparsityPattern &)
virtual void add_entries(const ArrayView< const std::pair< size_type, size_type >> &entries)
std::vector< Line > lines
void print(std::ostream &out) const
void reinit(const size_type m, const size_type n, const IndexSet &rowset=IndexSet())
void clear_row(const size_type row)
size_type max_entries_per_row() const
void print_gnuplot(std::ostream &out) const
size_type bandwidth() const
void compute_Tmmult_pattern(const SparsityPatternTypeLeft &left, const SparsityPatternTypeRight &right)
size_type n_nonzero_elements() const
bool exists(const size_type i, const size_type j) const
void add(const size_type i, const size_type j)
IndexSet nonempty_rows() const
size_type index_within_set(const size_type global_index) const
size_type n_elements() const
bool is_element(const size_type index) const
size_type nth_index_in_set(const size_type local_index) const
void add_indices(const ForwardIterator &begin, const ForwardIterator &end)
virtual void resize(const size_type rows, const size_type cols)
#define DEAL_II_NAMESPACE_OPEN
#define DEAL_II_NAMESPACE_CLOSE
static ::ExceptionBase & ExcInternalError()
static ::ExceptionBase & ExcDimensionMismatch(std::size_t arg1, std::size_t arg2)
#define Assert(cond, exc)
#define AssertDimension(dim1, dim2)
#define AssertIndexRange(index, range)
static ::ExceptionBase & ExcIO()
static ::ExceptionBase & ExcMessage(std::string arg1)
static ::ExceptionBase & ExcNotQuadratic()
#define AssertThrow(cond, exc)
IndexSet complete_index_set(const IndexSet::size_type N)
types::global_dof_index size_type
std::enable_if_t< std::is_fundamental< T >::value, std::size_t > memory_consumption(const T &t)
SymmetricTensor< 2, dim, Number > b(const Tensor< 2, dim, Number > &F)
VectorType::value_type * begin(VectorType &V)
VectorType::value_type * end(VectorType &V)
Iterator lower_bound(Iterator first, Iterator last, const T &val)
const types::global_dof_index invalid_size_type
unsigned int global_dof_index
void add_entries(ForwardIterator begin, ForwardIterator end, const bool indices_are_sorted)
std::vector< size_type > entries
size_type memory_consumption() const