* default argument keeps all
* entries.
*/
- CompressedSimpleSparsityPattern (const unsigned int m,
- const unsigned int n,
+ CompressedSimpleSparsityPattern (const types::global_dof_index m,
+ const types::global_dof_index n,
const IndexSet & rowset = IndexSet());
/**
* Initialize a square matrix of
* dimension @p n.
*/
- CompressedSimpleSparsityPattern (const unsigned int n);
+ CompressedSimpleSparsityPattern (const types::global_dof_index n);
/**
* Copy operator. For this the
* default argument keeps all
* entries.
*/
- void reinit (const unsigned int m,
- const unsigned int n,
+ void reinit (const types::global_dof_index m,
+ const types::global_dof_index n,
const IndexSet & rowset = IndexSet());
/**
* matrix. If the entry already
* exists, nothing bad happens.
*/
- void add (const unsigned int i,
- const unsigned int j);
+ void add (const types::global_dof_index i,
+ const types::global_dof_index j);
/**
* Add several nonzero entries to the
* happens.
*/
template <typename ForwardIterator>
- void add_entries (const unsigned int row,
- ForwardIterator begin,
- ForwardIterator end,
- const bool indices_are_unique_and_sorted = false);
+ void add_entries (const types::global_dof_index row,
+ ForwardIterator begin,
+ ForwardIterator end,
+ const bool indices_are_unique_and_sorted = false);
/**
* Check if a value at a certain
* position may be non-zero.
*/
- bool exists (const unsigned int i,
- const unsigned int j) const;
+ bool exists (const types::global_dof_index i,
+ const types::global_dof_index j) const;
/**
* Make the sparsity pattern
* matrix, which equals the dimension
* of the image space.
*/
- unsigned int n_rows () const;
+ types::global_dof_index n_rows () const;
/**
* Return number of columns of this
* matrix, which equals the dimension
* of the range space.
*/
- unsigned int n_cols () const;
+ types::global_dof_index n_cols () const;
/**
* Number of entries in a
* index set of rows that we want
* to store.
*/
- unsigned int row_length (const unsigned int row) const;
+ unsigned int row_length (const types::global_dof_index row) const;
/**
* Access to column number field.
* Return the column number of
* the @p indexth entry in @p row.
*/
- unsigned int column_number (const unsigned int row,
- const unsigned int index) const;
+ unsigned int column_number (const types::global_dof_index row,
+ const types::global_dof_index index) const;
/**
* Return an iterator that can loop over
* row. Dereferencing the iterator yields
* a column index.
*/
- row_iterator row_begin (const unsigned int row) const;
+ row_iterator row_begin (const types::global_dof_index row) const;
/**
* Returns the end of the current row.
*/
- row_iterator row_end (const unsigned int row) const;
+ row_iterator row_end (const types::global_dof_index row) const;
/**
* Compute the bandwidth of the matrix
* represented by this structure. The
* Number of rows that this sparsity
* structure shall represent.
*/
- unsigned int rows;
+ types::global_dof_index rows;
/**
* Number of columns that this sparsity
* structure shall represent.
*/
- unsigned int cols;
+ types::global_dof_index cols;
/**
* A set that contains the valid rows.
* Add the given column number to
* this line.
*/
- void add (const unsigned int col_num);
+ void add (const types::global_dof_index col_num);
/**
* Add the columns specified by the
inline
void
-CompressedSimpleSparsityPattern::Line::add (const unsigned int j)
+CompressedSimpleSparsityPattern::Line::add (const types::global_dof_index j)
{
// first check the last element (or if line
// is still empty)
inline
-unsigned int
+types::global_dof_index
CompressedSimpleSparsityPattern::n_rows () const
{
return rows;
inline
-unsigned int
+types::global_dof_index
CompressedSimpleSparsityPattern::n_cols () const
{
return cols;
inline
void
-CompressedSimpleSparsityPattern::add (const unsigned int i,
- const unsigned int j)
+CompressedSimpleSparsityPattern::add (const types::global_dof_index i,
+ const types::global_dof_index j)
{
Assert (i<rows, ExcIndexRange(i, 0, rows));
Assert (j<cols, ExcIndexRange(j, 0, cols));
template <typename ForwardIterator>
inline
void
-CompressedSimpleSparsityPattern::add_entries (const unsigned int row,
+CompressedSimpleSparsityPattern::add_entries (const types::global_dof_index row,
ForwardIterator begin,
ForwardIterator end,
const bool indices_are_sorted)
inline
unsigned int
-CompressedSimpleSparsityPattern::row_length (const unsigned int row) const
+CompressedSimpleSparsityPattern::row_length (const types::global_dof_index row) const
{
Assert (row < n_rows(), ExcIndexRange (row, 0, n_rows()));
if (rowset.size() > 0 && !rowset.is_element(row))
inline
unsigned int
-CompressedSimpleSparsityPattern::column_number (const unsigned int row,
- const unsigned int index) const
+CompressedSimpleSparsityPattern::column_number (const types::global_dof_index row,
+ const types::global_dof_index index) const
{
Assert (row < n_rows(), ExcIndexRange (row, 0, n_rows()));
Assert( rowset.size() == 0 || rowset.is_element(row), ExcInternalError());
inline
CompressedSimpleSparsityPattern::row_iterator
-CompressedSimpleSparsityPattern::row_begin (const unsigned int row) const
+CompressedSimpleSparsityPattern::row_begin (const types::global_dof_index row) const
{
Assert (row < n_rows(), ExcIndexRange (row, 0, n_rows()));
const unsigned int local_row = rowset.size() ? rowset.index_within_set(row) : row;
inline
CompressedSimpleSparsityPattern::row_iterator
-CompressedSimpleSparsityPattern::row_end (const unsigned int row) const
+CompressedSimpleSparsityPattern::row_end (const types::global_dof_index row) const
{
Assert (row < n_rows(), ExcIndexRange (row, 0, n_rows()));
const unsigned int local_row = rowset.size() ? rowset.index_within_set(row) : row;
-CompressedSimpleSparsityPattern::CompressedSimpleSparsityPattern (const unsigned int m,
- const unsigned int n,
+CompressedSimpleSparsityPattern::CompressedSimpleSparsityPattern (const types::global_dof_index m,
+ const types::global_dof_index n,
const IndexSet & rowset_
)
:
-CompressedSimpleSparsityPattern::CompressedSimpleSparsityPattern (const unsigned int n)
+CompressedSimpleSparsityPattern::CompressedSimpleSparsityPattern (const types::global_dof_index n)
:
rows(0),
cols(0),
void
-CompressedSimpleSparsityPattern::reinit (const unsigned int m,
- const unsigned int n,
+CompressedSimpleSparsityPattern::reinit (const types::global_dof_index m,
+ const types::global_dof_index n,
const IndexSet & rowset_)
{
rows = m;
bool
-CompressedSimpleSparsityPattern::exists (const unsigned int i,
- const unsigned int j) const
+CompressedSimpleSparsityPattern::exists (const types::global_dof_index i,
+ const types::global_dof_index j) const
{
Assert (i<rows, ExcIndexRange(i, 0, rows));
Assert (j<cols, ExcIndexRange(j, 0, cols));
// explicit instantiations
-template void CompressedSimpleSparsityPattern::Line::add_entries(unsigned int *,
- unsigned int *,
+template void CompressedSimpleSparsityPattern::Line::add_entries(types::global_dof_index *,
+ types::global_dof_index *,
const bool);
-template void CompressedSimpleSparsityPattern::Line::add_entries(const unsigned int *,
- const unsigned int *,
+template void CompressedSimpleSparsityPattern::Line::add_entries(const types::global_dof_index *,
+ const types::global_dof_index *,
const bool);
#ifndef DEAL_II_VECTOR_ITERATOR_IS_POINTER
template void CompressedSimpleSparsityPattern::Line::