* Constructor fixing the
* dimensions.
*/
- BlockMatrixArray (const size_type n_block_rows,
- const size_type n_block_cols);
+ BlockMatrixArray (const unsigned int n_block_rows,
+ const unsigned int n_block_cols);
/**
* Initialize object
* created by the default
* constructor.
*/
- void initialize (const size_type n_block_rows,
- const size_type n_block_cols);
+ void initialize (const unsigned int n_block_rows,
+ const unsigned int n_block_cols);
/**
* Constructor fixing the
* @deprecated The last argument is ignored. Use the constructor with only
* the first two arguments.
*/
- BlockMatrixArray (const size_type n_block_rows,
- const size_type n_block_cols,
+ BlockMatrixArray (const unsigned int n_block_rows,
+ const unsigned int n_block_cols,
VectorMemory<Vector<number> > &mem) DEAL_II_DEPRECATED;
/**
* @deprecated The last argument is ignored. Use the function with same name
* but only the first two arguments.
*/
- void initialize (const size_type n_block_rows,
- const size_type n_block_cols,
+ void initialize (const unsigned int n_block_rows,
+ const unsigned int n_block_cols,
VectorMemory<Vector<number> > &mem) DEAL_II_DEPRECATED;
/**
* Adjust the matrix to a new
* size and delete all blocks.
*/
- void reinit (const size_type n_block_rows,
- const size_type n_block_cols);
+ void reinit (const unsigned int n_block_rows,
+ const unsigned int n_block_cols);
/**
* Add a block matrix entry. The
* the multiplication functions.
*/
template <class MATRIX>
- void enter (const MATRIX &matrix,
- const size_type row,
- const size_type col,
- const double prefix = 1.,
- const bool transpose = false);
+ void enter (const MATRIX &matrix,
+ const unsigned int row,
+ const unsigned int col,
+ const double prefix = 1.,
+ const bool transpose = false);
/**
* Add an entry like with enter,
*/
template <class MATRIX>
void enter_aux (VectorMemory<Vector<number> > &mem,
- const MATRIX &matrix,
- const size_type row,
- const size_type col,
- const double prefix = 1.,
- const bool transpose = false) DEAL_II_DEPRECATED;
+ const MATRIX &matrix,
+ const unsigned int row,
+ const unsigned int col,
+ const double prefix = 1.,
+ const bool transpose = false) DEAL_II_DEPRECATED;
/**
* Number of block-entries per
* column.
*/
- size_type n_block_rows () const;
+ unsigned int n_block_rows () const;
/**
* Number of block-entries per
* row.
*/
- size_type n_block_cols () const;
+ unsigned int n_block_cols () const;
/**
* Matrix-vector multiplication.
/**
* Number of blocks per column.
*/
- size_type block_rows;
+ unsigned int block_rows;
/**
* number of blocks per row.
*/
- size_type block_cols;
+ unsigned int block_cols;
};
/*@}*/
* <tt>n_blocks</tt> is the
* number of blocks in each direction.
*/
- BlockTrianglePrecondition (const size_type n_blocks);
+ BlockTrianglePrecondition (const unsigned int n_blocks);
/**
* Constructor. This matrix must be
* @deprecated The second argument is ignored. Use the constructor with only
* the first and third argument.
*/
- BlockTrianglePrecondition (const size_type n_block_rows,
+ BlockTrianglePrecondition (const unsigned int n_block_rows,
VectorMemory<Vector<number> > &mem,
const bool backward = false) DEAL_II_DEPRECATED;
* @deprecated The second argument
* is ignored. Use the function without that argument.
*/
- void initialize (const size_type n_block_rows,
+ void initialize (const unsigned int n_block_rows,
VectorMemory<Vector<number> > &mem,
const bool backward = false) DEAL_II_DEPRECATED;
* Resize preconditioner to a new
* size and clear all blocks.
*/
- void reinit (const size_type n_block_rows);
+ void reinit (const unsigned int n_block_rows);
/**
void
BlockMatrixArray<number>::enter (
const MATRIX &matrix,
- size_type row,
- size_type col,
+ unsigned int row,
+ unsigned int col,
double prefix,
bool transpose)
{
BlockMatrixArray<number>::enter_aux (
VectorMemory<Vector<number> > &mem,
const MATRIX &matrix,
- size_type row,
- size_type col,
+ unsigned int row,
+ unsigned int col,
double prefix,
bool transpose)
{
array(m->row, m->col) += stream.str();
}
- for (size_type i=0; i<n_block_rows(); ++i)
- for (size_type j=0; j<n_block_cols(); ++j)
+ for (unsigned int i=0; i<n_block_rows(); ++i)
+ for (unsigned int j=0; j<n_block_cols(); ++j)
{
out << '\t' << array(i,j);
if (j==n_block_cols()-1)
* Stores the number of DoFs before the
* refinement and/or coarsening.
*/
- unsigned int n_dofs_old;
+ types::global_dof_index n_dofs_old;
/**
* Declaration of
template <class VectorType>
double
get_vector_element (const VectorType &vector,
- const unsigned int cell_number)
+ const types::global_dof_index cell_number)
{
return vector[cell_number];
}
double
get_vector_element (const IndexSet &is,
- const unsigned int cell_number)
+ const types::global_dof_index cell_number)
{
return (is.is_element(cell_number) ? 1 : 0);
}
template <typename number>
BlockMatrixArray<number>::BlockMatrixArray (
- const size_type n_block_rows,
- const size_type n_block_cols)
+ const unsigned int n_block_rows,
+ const unsigned int n_block_cols)
: block_rows (n_block_rows),
block_cols (n_block_cols)
{}
template <typename number>
BlockMatrixArray<number>::BlockMatrixArray (
- const size_type n_block_rows,
- const size_type n_block_cols,
+ const unsigned int n_block_rows,
+ const unsigned int n_block_cols,
VectorMemory<Vector<number> > &)
: block_rows (n_block_rows),
block_cols (n_block_cols)
template <typename number>
void
BlockMatrixArray<number>::initialize (
- const size_type n_block_rows,
- const size_type n_block_cols,
+ const unsigned int n_block_rows,
+ const unsigned int n_block_cols,
VectorMemory<Vector<number> > &)
{
block_rows = n_block_rows;
template <typename number>
void
BlockMatrixArray<number>::initialize (
- const size_type n_block_rows,
- const size_type n_block_cols)
+ const unsigned int n_block_rows,
+ const unsigned int n_block_cols)
{
block_rows = n_block_rows;
block_cols = n_block_cols;
template <typename number>
void
BlockMatrixArray<number>::reinit (
- const size_type n_block_rows,
- const size_type n_block_cols)
+ const unsigned int n_block_rows,
+ const unsigned int n_block_cols)
{
clear();
block_rows = n_block_rows;
number result = 0.;
- for (size_type i=0; i<block_rows; ++i)
+ for (unsigned int i=0; i<block_rows; ++i)
{
aux.reinit(u.block(i));
for (m = entries.begin(); m != end ; ++m)
template <typename number>
-typename BlockMatrixArray<number>::size_type
+unsigned int
BlockMatrixArray<number>::n_block_rows () const
{
return block_rows;
template <typename number>
-typename BlockMatrixArray<number>::size_type
+unsigned int
BlockMatrixArray<number>::n_block_cols () const
{
return block_cols;
template <typename number>
BlockTrianglePrecondition<number>::BlockTrianglePrecondition(
- const size_type block_rows,
+ const unsigned int block_rows,
VectorMemory<Vector<number> > &,
const bool backward)
:
template <typename number>
BlockTrianglePrecondition<number>::BlockTrianglePrecondition(
- const size_type block_rows)
+ const unsigned int block_rows)
:
BlockMatrixArray<number> (block_rows, block_rows),
backward(false)
template <typename number>
void
BlockTrianglePrecondition<number>::initialize(
- const size_type n_block_rows,
+ const unsigned int n_block_rows,
VectorMemory<Vector<number> > &,
const bool backward)
{
template <typename number>
void
BlockTrianglePrecondition<number>::reinit (
- const size_type n)
+ const unsigned int n)
{
BlockMatrixArray<number>::reinit(n,n);
}
if (backward)
{
- for (size_type i=n_block_rows(); i>0;)
+ for (unsigned int i=n_block_rows(); i>0;)
do_row(dst, --i);
}
else
{
- for (size_type i=0; i<n_block_rows(); ++i)
+ for (unsigned int i=0; i<n_block_rows(); ++i)
do_row(dst, i);
}
// maps with the respective indices.
std::vector<std::map<types::global_dof_index,double> > block_boundary_values(n_blocks);
{
- int offset = 0, block=0;
+ int block=0;
+ types::global_dof_index offset = 0;
for (std::map<types::global_dof_index,double>::const_iterator
dof = boundary_values.begin();
dof != boundary_values.end();
std::vector<types::global_dof_index>
local_dof_indices (dof_handler->get_fe ().dofs_per_cell);
- std::vector <int> new_solution_indices;
+#ifndef deal_ii_use_large_index_type
+ std::vector <int> new_solution_indices;
+#else
+ std::vector <long long int> new_solution_indices;
+#endif
current_cell->get_dof_indices (local_dof_indices);
// there is an implicit assumption here
// that all the closest support point to
for (unsigned int point = 0; point < locations.size (); point++)
{
current_cell[point]->get_dof_indices (local_dof_indices);
+#ifndef deal_ii_use_large_index_type
std::vector <int> new_solution_indices;
+#else
+ std::vector <long long int> new_solution_indices;
+#endif
for (unsigned int component = 0; component < dof_handler->get_fe ().n_components (); component++)
{