for (unsigned int d=0; d<dofs_per_vertex; ++d, ++index)
accessor.set_vertex_dof_index(vertex,d,
local_dof_indices[index]);
- //TODO[bt] the function dof_index expects two unsigned int (I am not
- //sure what should be the type of fe_index) but the following loop
- //seems to do nothing but incrementing index.
for (unsigned int d=0; d<dofs_per_line; ++d, ++index)
accessor.dof_index(d, local_dof_indices[index]);
dst = 0.;
- for (size_type row=0; row<n_block_rows(); ++row)
- for (size_type col=0; col<n_block_cols(); ++col)
+ for (unsigned int row=0; row<n_block_rows(); ++row)
+ for (unsigned int col=0; col<n_block_cols(); ++col)
block(row,col).vmult_add (dst.block(row),
src.block(col));
}
Assert (src.n_blocks() == n_block_cols(),
ExcDimensionMismatch(src.n_blocks(), n_block_cols()));
- for (size_type row=0; row<n_block_rows(); ++row)
- for (size_type col=0; col<n_block_cols(); ++col)
+ for (unsigned int row=0; row<n_block_rows(); ++row)
+ for (unsigned int col=0; col<n_block_cols(); ++col)
block(row,col).vmult_add (dst.block(row),
src.block(col));
}
* system. Using the add() functions of this class, it is possible to
* use the standard assembling functions used for block matrices, but
* only enter in one of the blocks and still avoiding the index
- * computations innvolved.
+ * computations involved.
* The reason for this class is, that we may need a different number
* of matrices for different blocks in a block system. For example, a
/**
* Reinitialize the matrix for a
* new BlockSparsityPattern. This
- * adujusts the #matrix as well
+ * adjusts the #matrix as well
* as the #row_indices and
* #column_indices.
*
* position of the data member
* matrix on the global matrix.
*/
- unsigned int row;
+ size_type row;
/**
* Column coordinate. This is
* the position of the data
* member matrix on the global
* matrix.
*/
- unsigned int column;
+ size_type column;
/**
* The matrix itself
inline
MatrixBlock<MATRIX>::MatrixBlock()
:
- row(deal_II_numbers::invalid_unsigned_int),
- column(deal_II_numbers::invalid_unsigned_int)
+ row(deal_II_numbers::invalid_size_type),
+ column(deal_II_numbers::invalid_size_type)
{}
{
public:
PointGeometryData(const Point <dim> &new_requested_location, const std::vector <Point <dim> > &new_locations,
- const std::vector <int> &new_sol_indices);
+ const std::vector <types::global_dof_index> &new_sol_indices);
Point <dim> requested_location;
std::vector <Point <dim> > support_point_locations;
- std::vector <int> solution_indices;
+ std::vector <types::global_dof_index> solution_indices;
};
}
}
#ifdef DEBUG
if (true)
{
- types::global_dof_index max_element = 0;
+ types::global_dof_index max_element = static_cast<types::global_dof_index>(0);
for (std::vector<types::global_dof_index>::const_iterator i=dof_to_boundary_mapping.begin();
i!=dof_to_boundary_mapping.end(); ++i)
if ((*i != hp::DoFHandler<dim,spacedim>::invalid_dof_index) &&
// in the block in which this
// dof is located
const types::global_dof_index dof_number = dof->first;
- const std::pair<types::global_dof_index,unsigned int>
+ const std::pair<unsigned int,types::global_dof_index>
block_index = index_mapping.global_to_local (dof_number);
// for each boundary dof:
PointGeometryData<dim>
::PointGeometryData (const Point <dim> &new_requested_location,
const std::vector <Point <dim> > &new_locations,
- const std::vector <int> &new_sol_indices)
+ const std::vector <types::global_dof_index> &new_sol_indices)
{
requested_location = new_requested_location;
support_point_locations = new_locations;
std::vector<types::global_dof_index>
local_dof_indices (dof_handler->get_fe ().dofs_per_cell);
- std::vector <int> new_solution_indices;
+ std::vector <types::global_dof_index> new_solution_indices;
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);
- std::vector <int> new_solution_indices;
+ std::vector<types::global_dof_index> new_solution_indices;
for (unsigned int component = 0; component < dof_handler->get_fe ().n_components (); component++)
{