/**
* Abbreviation for the data type stored by this object.
*/
- typedef boost::variant<int,unsigned int,double,std::string> value_type;
+ typedef boost::variant<int,unsigned int,unsigned long long int,double,std::string> value_type;
/**
* Stored value.
const unsigned int starting_offset = dof_handler.vertex_dofs_offsets[vertex_index];
const types::global_dof_index *pointer = &dof_handler.vertex_dofs[starting_offset];
- Assert (*pointer != numbers::invalid_unsigned_int,
+ Assert (*pointer != numbers::invalid_size_type,
ExcInternalError());
unsigned int counter = 0;
{
Assert (pointer <= &dof_handler.vertex_dofs.back(), ExcInternalError());
- Assert((*pointer)<std::numeric_limits<unsigned int>::max(), ExcInternalError());
+ Assert((*pointer)<std::numeric_limits<types::global_dof_index>::max(), ExcInternalError());
const unsigned int this_fe_index = static_cast<unsigned int>(*pointer);
if (this_fe_index == numbers::invalid_unsigned_int)
dofs_per_cell[0] : dofs_per_cell[cell_active_fe_index[cell_number]];
for (unsigned int i=0; i<dofs_this_cell; i++)
{
- types::global_dof_index current_dof =
+ types::global_dof_index current_dof =
local_indices[lexicographic_inv[i]];
const std::vector<std::pair<types::global_dof_index,double> >
*entries_ptr =
{
for (unsigned int i=0; i<dofs_this_cell; ++i)
{
- types::global_dof_index current_dof =
+ types::global_dof_index current_dof =
local_indices[lexicographic_inv[i]];
if (n_mpi_procs > 1 &&
(current_dof < first_owned ||
// loop over all local dofs. ind_local holds local number on cell, index
// iterates over the elements of index_local_to_global and dof_indices
// points to the global indices stored in index_local_to_global
- const unsigned int *dof_indices = dof_info.begin_indices(cell);
+ const types::global_dof_index *dof_indices = dof_info.begin_indices(cell);
const std::pair<unsigned short,unsigned short> *indicators =
dof_info.begin_indicators(cell);
const std::pair<unsigned short,unsigned short> *indicators_end =
AssertDimension (n_fe, constraint.size());
std::vector<types::global_dof_index> local_dof_indices;
- std::vector<std::vector<unsigned int> > ghost_dofs(n_fe);
+ std::vector<std::vector<types::global_dof_index> > ghost_dofs(n_fe);
std::vector<std::vector<std::vector<unsigned int> > > lexicographic_inv(n_fe);
internal::MatrixFreeFunctions::ConstraintValues<double> constraint_values;
// cache the constrained indices for use in matrix-vector products
{
- const unsigned int
+ const types::global_dof_index
start_index = dof_info[no].vector_partitioner->local_range().first,
end_index = dof_info[no].vector_partitioner->local_range().second;
- for (unsigned int i=start_index; i<end_index; ++i)
+ for (types::global_dof_index i=start_index; i<end_index; ++i)
if (constraint[no]->is_constrained(i)==true)
dof_info[no].constrained_dofs.push_back(i-start_index);
}
subface->get_dof_indices (slave_dofs, subface_fe_index);
for (unsigned int i=0; i<slave_dofs.size(); ++i)
- Assert (slave_dofs[i] != numbers::invalid_unsigned_int,
+ Assert (slave_dofs[i] != numbers::invalid_dof_index,
ExcInternalError());
// Now create the element constraint for this