*/
template <int spacedim>
static
- unsigned int
+ types::global_dof_index
get_dof_index (const dealii::DoFHandler<1,spacedim> &dof_handler,
const unsigned int obj_level,
const unsigned int obj_index,
const unsigned int fe_index,
const unsigned int local_index,
dealii::internal::int2type<1>,
- const unsigned int global_index)
+ const types::global_dof_index global_index)
{
dof_handler.levels[obj_level]->lines.
set_dof_index (dof_handler,
template <int spacedim>
static
- unsigned int
+ types::global_dof_index
get_dof_index (const dealii::DoFHandler<2,spacedim> &dof_handler,
const unsigned int obj_level,
const unsigned int obj_index,
const unsigned int fe_index,
const unsigned int local_index,
dealii::internal::int2type<1>,
- const unsigned int global_index)
+ const types::global_dof_index global_index)
{
// faces have no levels
Assert (obj_level == 0, ExcInternalError());
template <int spacedim>
static
- unsigned int
+ types::global_dof_index
get_dof_index (const dealii::DoFHandler<2,spacedim> &dof_handler,
const unsigned int obj_level,
const unsigned int obj_index,
const unsigned int fe_index,
const unsigned int local_index,
dealii::internal::int2type<2>,
- const unsigned int global_index)
+ const types::global_dof_index global_index)
{
dof_handler.levels[obj_level]->quads.
set_dof_index (dof_handler,
template <int spacedim>
static
- unsigned int
+ types::global_dof_index
get_dof_index (const dealii::DoFHandler<3,spacedim> &dof_handler,
const unsigned int obj_level,
const unsigned int obj_index,
const unsigned int fe_index,
const unsigned int local_index,
dealii::internal::int2type<1>,
- const unsigned int global_index)
+ const types::global_dof_index global_index)
{
// faces have no levels
Assert (obj_level == 0, ExcInternalError());
template <int spacedim>
static
- unsigned int
+ types::global_dof_index
get_dof_index (const dealii::DoFHandler<3,spacedim> &dof_handler,
const unsigned int obj_level,
const unsigned int obj_index,
const unsigned int fe_index,
const unsigned int local_index,
dealii::internal::int2type<2>,
- const unsigned int global_index)
+ const types::global_dof_index global_index)
{
// faces have no levels
Assert (obj_level == 0, ExcInternalError());
template <int spacedim>
static
- unsigned int
+ types::global_dof_index
get_dof_index (const dealii::DoFHandler<3,spacedim> &dof_handler,
const unsigned int obj_level,
const unsigned int obj_index,
const unsigned int fe_index,
const unsigned int local_index,
dealii::internal::int2type<3>,
- const unsigned int global_index)
+ const types::global_dof_index global_index)
{
dof_handler.levels[obj_level]->hexes.
set_dof_index (dof_handler,
template <int spacedim>
static
- unsigned int
+ types::global_dof_index
get_dof_index (const dealii::hp::DoFHandler<1,spacedim> &dof_handler,
const unsigned int obj_level,
const unsigned int obj_index,
const unsigned int fe_index,
const unsigned int local_index,
const dealii::internal::int2type<1> &,
- const unsigned int global_index)
+ const types::global_dof_index global_index)
{
dof_handler.levels[obj_level]->lines.
set_dof_index (dof_handler,
template <int spacedim>
static
- unsigned int
+ types::global_dof_index
get_dof_index (const dealii::hp::DoFHandler<2,spacedim> &dof_handler,
const unsigned int obj_level,
const unsigned int obj_index,
const unsigned int fe_index,
const unsigned int local_index,
const dealii::internal::int2type<1> &,
- const unsigned int global_index)
+ const types::global_dof_index global_index)
{
dof_handler.faces->lines.
set_dof_index (dof_handler,
template <int spacedim>
static
- unsigned int
+ types::global_dof_index
get_dof_index (const dealii::hp::DoFHandler<2,spacedim> &dof_handler,
const unsigned int obj_level,
const unsigned int obj_index,
const unsigned int fe_index,
const unsigned int local_index,
const dealii::internal::int2type<2> &,
- const unsigned int global_index)
+ const types::global_dof_index global_index)
{
dof_handler.levels[obj_level]->quads.
set_dof_index (dof_handler,
template <int spacedim>
static
- unsigned int
+ types::global_dof_index
get_dof_index (const dealii::hp::DoFHandler<3,spacedim> &dof_handler,
const unsigned int obj_level,
const unsigned int obj_index,
const unsigned int fe_index,
const unsigned int local_index,
const dealii::internal::int2type<1> &,
- const unsigned int global_index)
+ const types::global_dof_index global_index)
{
dof_handler.faces->lines.
set_dof_index (dof_handler,
template <int spacedim>
static
- unsigned int
+ types::global_dof_index
get_dof_index (const dealii::hp::DoFHandler<3,spacedim> &dof_handler,
const unsigned int obj_level,
const unsigned int obj_index,
const unsigned int fe_index,
const unsigned int local_index,
const dealii::internal::int2type<2> &,
- const unsigned int global_index)
+ const types::global_dof_index global_index)
{
dof_handler.faces->quads.
set_dof_index (dof_handler,
template <int spacedim>
static
- unsigned int
+ types::global_dof_index
get_dof_index (const dealii::hp::DoFHandler<3,spacedim> &dof_handler,
const unsigned int obj_level,
const unsigned int obj_index,
const unsigned int fe_index,
const unsigned int local_index,
const dealii::internal::int2type<3> &,
- const unsigned int global_index)
+ const types::global_dof_index global_index)
{
dof_handler.levels[obj_level]->hexes.
set_dof_index (dof_handler,
const unsigned int vertex_index,
const unsigned int fe_index,
const unsigned int local_index,
- const unsigned int global_index)
+ const types::global_dof_index global_index)
{
Assert ((fe_index == dealii::DoFHandler<dim,spacedim>::default_fe_index),
ExcMessage ("Only the default FE index is allowed for non-hp DoFHandler objects"));
const unsigned int vertex_index,
const unsigned int fe_index,
const unsigned int local_index,
- const unsigned int global_index)
+ const types::global_dof_index global_index)
{
Assert ( (fe_index != dealii::hp::DoFHandler<dim,spacedim>::default_fe_index),
ExcMessage ("You need to specify a FE index when working "
// we can't find a set for this
// particular fe_index
const unsigned int starting_offset = dof_handler.vertex_dofs_offsets[vertex_index];
- unsigned int *pointer = &dof_handler.vertex_dofs[starting_offset];
+ types::global_dof_index *pointer = &dof_handler.vertex_dofs[starting_offset];
while (true)
{
Assert (pointer <= &dof_handler.vertex_dofs.back(), ExcInternalError());
- const unsigned int this_fe_index = *pointer;
+ // a fe index is always small
+ Assert((*pointer)<numeric_limits<unsigned int>::max(), ExcInternalError());
+ const unsigned int this_fe_index = static_cast<unsigned int>(*pointer);
Assert (this_fe_index != numbers::invalid_unsigned_int,
ExcInternalError());
// we can't find a set for this
// particular fe_index
const unsigned int starting_offset = dof_handler.vertex_dofs_offsets[vertex_index];
- const unsigned int *pointer = &dof_handler.vertex_dofs[starting_offset];
+ const types:global_dof_index *pointer = &dof_handler.vertex_dofs[starting_offset];
while (true)
{
Assert (pointer <= &dof_handler.vertex_dofs.back(), ExcInternalError());
- const unsigned int this_fe_index = *pointer;
+ Assert((*pointer)<numeric_limits<unsigned int>::max(), ExcInternalError());
+ const unsigned int this_fe_index = static_cast<unsigned int>(*pointer);
Assert (this_fe_index != numbers::invalid_unsigned_int,
ExcInternalError());
// sets and count the number of
// hops
const unsigned int starting_offset = dof_handler.vertex_dofs_offsets[vertex_index];
- const unsigned int *pointer = &dof_handler.vertex_dofs[starting_offset];
+ const types::global_dof_index *pointer = &dof_handler.vertex_dofs[starting_offset];
Assert (*pointer != numbers::invalid_unsigned_int,
ExcInternalError());
{
Assert (pointer <= &dof_handler.vertex_dofs.back(), ExcInternalError());
- const unsigned int this_fe_index = *pointer;
+ Assert((*pointer)<numeric_limits<unsigned int>::max(), ExcInternalError());
+ const unsigned int this_fe_index = static_cast<unsigned int>(*pointer);
if (this_fe_index == numbers::invalid_unsigned_int)
return counter;
// sets and count the number of
// hops
const unsigned int starting_offset = dof_handler.vertex_dofs_offsets[vertex_index];
- const unsigned int *pointer = &dof_handler.vertex_dofs[starting_offset];
+ const types::global_dof_index *pointer = &dof_handler.vertex_dofs[starting_offset];
Assert (*pointer != numbers::invalid_unsigned_int,
ExcInternalError());
{
Assert (pointer <= &dof_handler.vertex_dofs.back(), ExcInternalError());
- const unsigned int this_fe_index = *pointer;
+ Assert((*pointer)<numeric_limits<unsigned int>::max(), ExcInternalError());
+ const unsigned int this_fe_index = static_cast<unsigned int>(*pointer);
Assert (this_fe_index < dof_handler.finite_elements->size(),
ExcInternalError());
// sets and see whether we find
// the given index
const unsigned int starting_offset = dof_handler.vertex_dofs_offsets[vertex_index];
- const unsigned int *pointer = &dof_handler.vertex_dofs[starting_offset];
+ const types::global_dof_index *pointer = &dof_handler.vertex_dofs[starting_offset];
Assert (*pointer != numbers::invalid_unsigned_int,
ExcInternalError());
{
Assert (pointer <= &dof_handler.vertex_dofs.back(), ExcInternalError());
- const unsigned int this_fe_index = *pointer;
+ Assert((*pointer)<numeric_limits<unsigned int>::max(), ExcInternalError());
+ const unsigned int this_fe_index = static_cast<unsigned int>(*pointer);
Assert (this_fe_index < dof_handler.finite_elements->size(),
ExcInternalError());
template<int structdim, class DH>
inline
-unsigned int DoFAccessor<structdim, DH>::mg_dof_index (const int level, const unsigned int i) const {
+types::global_dof_index DoFAccessor<structdim, DH>::mg_dof_index (const int level, const unsigned int i) const {
return this->dof_handler->template get_dof_index<structdim> (level, this->present_index, 0, i);
}
inline
void
DoFAccessor<dim,DH>::set_dof_index (const unsigned int i,
- const unsigned int index,
+ const types::global_dof_index index,
const unsigned int fe_index) const
{
// access the respective DoF
template<int structdim, class DH>
inline
unsigned
+types::global_dof_index
DoFAccessor<structdim, DH>::mg_vertex_dof_index (const int level, const unsigned int vertex, const unsigned int i, const unsigned int fe_index) const {
Assert (this->dof_handler != 0, ExcInvalidObject ());
Assert (&this->dof_handler->get_fe () != 0, ExcInvalidObject ());
void
DoFAccessor<structdim, DH>::set_vertex_dof_index (const unsigned int vertex,
const unsigned int i,
- const unsigned int index,
+ const types::global_dof_index index,
const unsigned int fe_index) const
{
dealii::internal::DoFAccessor::Implementation::set_vertex_dof_index
template<int structdim, class DH>
inline
void
-DoFAccessor<structdim, DH>::set_mg_vertex_dof_index (const int level, const unsigned int vertex, const unsigned int i, const unsigned int index, const unsigned int fe_index) const {
+DoFAccessor<structdim, DH>::set_mg_vertex_dof_index (const int level, const unsigned int vertex, const unsigned int i, const types::global_dof_index index, const unsigned int fe_index) const {
Assert (this->dof_handler != 0, ExcInvalidObject ());
Assert (&this->dof_handler->get_fe () != 0, ExcInvalidObject ());
Assert (vertex < GeometryInfo<structdim>::vertices_per_cell, ExcIndexRange (vertex, 0, GeometryInfo<structdim>::vertices_per_cell));
template<int structdim, class DH>
inline
void
-DoFAccessor<structdim, DH>::set_mg_dof_index (const int level, const unsigned int i, const unsigned int index) const {
+DoFAccessor<structdim, DH>::set_mg_dof_index (const int level, const unsigned int i, const types::global_dof_index index) const {
this->dof_handler->template set_dof_index<structdim> (level, this->present_index, 0, i, index);
}
{
template <class DH>
void get_dof_indices (const dealii::DoFAccessor<1,DH> &accessor,
- std::vector<unsigned int> &dof_indices,
+ std::vector<types::global_dof_index> &dof_indices,
const unsigned int fe_index)
{
const unsigned int dofs_per_vertex = accessor.get_fe(fe_index).dofs_per_vertex,
dofs_per_line = accessor.get_fe(fe_index).dofs_per_line;
- std::vector<unsigned int>::iterator next = dof_indices.begin();
+ std::vector<types::global_dof_index>::iterator next = dof_indices.begin();
for (unsigned int vertex=0; vertex<2; ++vertex)
for (unsigned int d=0; d<dofs_per_vertex; ++d)
*next++ = accessor.vertex_dof_index(vertex,d,fe_index);
template <class DH>
void get_dof_indices (const dealii::DoFAccessor<2,DH> &accessor,
- std::vector<unsigned int> &dof_indices,
+ std::vector<types::global_dof_index> &dof_indices,
const unsigned int fe_index)
{
const unsigned int dofs_per_vertex = accessor.get_fe(fe_index).dofs_per_vertex,
dofs_per_line = accessor.get_fe(fe_index).dofs_per_line,
dofs_per_quad = accessor.get_fe(fe_index).dofs_per_quad;
- std::vector<unsigned int>::iterator next = dof_indices.begin();
+ std::vector<types::global_dof_index>::iterator next = dof_indices.begin();
for (unsigned int vertex=0; vertex<4; ++vertex)
for (unsigned int d=0; d<dofs_per_vertex; ++d)
*next++ = accessor.vertex_dof_index(vertex,d,fe_index);
template <class DH>
void get_dof_indices (const dealii::DoFAccessor<3,DH> &accessor,
- std::vector<unsigned int> &dof_indices,
+ std::vector<types::global_dof_index> &dof_indices,
const unsigned int fe_index)
{
const unsigned int dofs_per_vertex = accessor.get_fe(fe_index).dofs_per_vertex,
dofs_per_line = accessor.get_fe(fe_index).dofs_per_line,
dofs_per_quad = accessor.get_fe(fe_index).dofs_per_quad,
dofs_per_hex = accessor.get_fe(fe_index).dofs_per_hex;
- std::vector<unsigned int>::iterator next = dof_indices.begin();
+ std::vector<types::global_dof_index>::iterator next = dof_indices.begin();
for (unsigned int vertex=0; vertex<8; ++vertex)
for (unsigned int d=0; d<dofs_per_vertex; ++d)
*next++ = accessor.vertex_dof_index(vertex,d,fe_index);
}
template<class DH>
- void get_mg_dof_indices (const dealii::DoFAccessor<1, DH>& accessor, const int level, std::vector<unsigned int>& dof_indices, const unsigned int fe_index) {
+ void get_mg_dof_indices (const dealii::DoFAccessor<1, DH>& accessor, const int level, std::vector<types::global_dof_index>& dof_indices, const unsigned int fe_index) {
const FiniteElement<DH::dimension, DH::space_dimension>& fe = accessor.get_dof_handler ().get_fe ()[fe_index];
- std::vector<unsigned int>::iterator next = dof_indices.begin ();
+ std::vector<types::global_dof_index>::iterator next = dof_indices.begin ();
for (unsigned int vertex = 0; vertex < GeometryInfo<1>::vertices_per_cell; ++vertex)
for (unsigned int dof = 0; dof < fe.dofs_per_vertex; ++dof)
}
template<class DH>
- void get_mg_dof_indices (const dealii::DoFAccessor<2, DH>& accessor, const int level, std::vector<unsigned int>& dof_indices, const unsigned int fe_index) {
+ void get_mg_dof_indices (const dealii::DoFAccessor<2, DH>& accessor, const int level, std::vector<types::global_dof_index>& dof_indices, const unsigned int fe_index) {
const FiniteElement<DH::dimension, DH::space_dimension>& fe = accessor.get_dof_handler ().get_fe ()[fe_index];
- std::vector<unsigned int>::iterator next = dof_indices.begin ();
+ std::vector<types::global_dof_index>::iterator next = dof_indices.begin ();
for (unsigned int vertex = 0; vertex < GeometryInfo<2>::vertices_per_cell; ++vertex)
for (unsigned int dof = 0; dof < fe.dofs_per_vertex; ++dof)
}
template<class DH>
- void get_mg_dof_indices (const dealii::DoFAccessor<3, DH>& accessor, const int level, std::vector<unsigned int>& dof_indices, const unsigned int fe_index) {
+ void get_mg_dof_indices (const dealii::DoFAccessor<3, DH>& accessor, const int level, std::vector<types::global_dof_index>& dof_indices, const unsigned int fe_index) {
const FiniteElement<DH::dimension, DH::space_dimension>& fe = accessor.get_dof_handler ().get_fe ()[fe_index];
- std::vector<unsigned int>::iterator next = dof_indices.begin ();
+ std::vector<types::global_dof_index>::iterator next = dof_indices.begin ();
for (unsigned int vertex = 0; vertex < GeometryInfo<3>::vertices_per_cell; ++vertex)
for (unsigned int dof = 0; dof < fe.dofs_per_vertex; ++dof)
template <int structdim, class DH>
inline
void
-DoFAccessor<structdim,DH>::get_dof_indices (std::vector<unsigned int> &dof_indices,
+DoFAccessor<structdim,DH>::get_dof_indices (std::vector<types::global_dof_index> &dof_indices,
const unsigned int fe_index) const
{
Assert (static_cast<unsigned int>(this->level()) < this->dof_handler->levels.size(),
template<int structdim, class DH>
inline
-void DoFAccessor<structdim, DH>::get_mg_dof_indices (const int level, std::vector<unsigned int>& dof_indices, const unsigned int fe_index) const {
+void DoFAccessor<structdim, DH>::get_mg_dof_indices (const int level, std::vector<types::global_dof_index>& dof_indices, const unsigned int fe_index) const {
Assert (this->dof_handler != 0, ExcInvalidObject ());
Assert (&this->dof_handler->get_fe () != 0, ExcInvalidObject ());
inline
void
DoFAccessor<0,DH<1,spacedim> >::
-get_dof_indices (std::vector<unsigned int> &dof_indices,
+get_dof_indices (std::vector<types::global_dof_index> &dof_indices,
const unsigned int fe_index) const
{
for (unsigned int i=0; i<dof_indices.size(); ++i)
->cell_dof_indices_cache.size(),
ExcInternalError());
- std::vector<unsigned int>::iterator next
+ std::vector<types::global_dof_index>::iterator next
= (accessor.dof_handler->levels[accessor.present_level]
->cell_dof_indices_cache.begin() + accessor.present_index * dofs_per_cell);
->cell_dof_indices_cache.size(),
ExcInternalError());
- std::vector<unsigned int>::iterator next
+ std::vector<types::global_dof_index>::iterator next
= (accessor.dof_handler->levels[accessor.present_level]
->cell_dof_indices_cache.begin() + accessor.present_index * dofs_per_cell);
->cell_dof_indices_cache.size(),
ExcInternalError());
- std::vector<unsigned int>::iterator next
+ std::vector<types::global_dof_index>::iterator next
= (accessor.dof_handler->levels[accessor.present_level]
->cell_dof_indices_cache.begin() + accessor.present_index * dofs_per_cell);
static
void
set_dof_indices (DoFCellAccessor<DoFHandler<1,spacedim> > &accessor,
- const std::vector<unsigned int> &local_dof_indices)
+ const std::vector<types::global_dof_index> &dof_indices)
{
Assert (accessor.has_children() == false,
ExcInternalError());
dofs_per_line = accessor.get_fe().dofs_per_line,
dofs_per_cell = accessor.get_fe().dofs_per_cell;
- Assert (local_dof_indices.size() == dofs_per_cell,
+ Assert (dof_indices.size() == dofs_per_cell,
ExcInternalError());
unsigned int index = 0;
static
void
set_dof_indices (DoFCellAccessor<DoFHandler<2,spacedim> > &accessor,
- const std::vector<unsigned int> &local_dof_indices)
+ const std::vector<types::global_dof_index> &local_dof_indices)
{
Assert (accessor.has_children() == false,
ExcInternalError());
static
void
set_dof_indices (DoFCellAccessor<DoFHandler<3,spacedim> > &accessor,
- const std::vector<unsigned int> &local_dof_indices)
+ const std::vector<types::global_dof_index> &dof_indices)
{
Assert (accessor.has_children() == false,
ExcInternalError());
dofs_per_hex = accessor.get_fe().dofs_per_hex,
dofs_per_cell = accessor.get_fe().dofs_per_cell;
- Assert (local_dof_indices.size() == dofs_per_cell,
+ Assert (dof_indices.size() == dofs_per_cell,
ExcInternalError());
unsigned int index = 0;
for (unsigned int vertex=0; vertex<8; ++vertex)
for (unsigned int d=0; d<dofs_per_vertex; ++d, ++index)
accessor.set_vertex_dof_index(vertex,d,
- local_dof_indices[index]);
+ dof_indices[index]);
// now copy dof numbers into the line. for
// lines with the wrong orientation, we have
// already made sure that we're ok by picking
static
void
set_dof_indices (const DoFCellAccessor<dealii::hp::DoFHandler<dim,spacedim> > &,
- const std::vector<unsigned int> &)
+ const std::vector<types::global_dof_index> &)
{
Assert (false, ExcNotImplemented());
}
static
void
get_dof_indices (const DoFCellAccessor<DoFHandler<dim,spacedim> > &accessor,
- std::vector<unsigned int> &dof_indices)
+ std::vector<types::global_dof_index> &dof_indices)
{
typedef
dealii::DoFAccessor<dim,DoFHandler<dim,spacedim> >
accessor.get_fe().dofs_per_vertex * GeometryInfo<dim>::vertices_per_cell),
ExcMessage ("Cell must either be active, or all DoFs must be in vertices"));
- unsigned int *cache = &accessor.dof_handler->levels[accessor.level()]
+ types::global_dof_index *cache = &accessor.dof_handler->levels[accessor.level()]
->cell_dof_indices_cache[accessor.present_index * accessor.get_fe().dofs_per_cell];
for (unsigned int i=0; i<accessor.get_fe().dofs_per_cell; ++i, ++cache)
dof_indices[i] = *cache;
static
void
get_dof_indices (const DoFCellAccessor<dealii::hp::DoFHandler<dim,spacedim> > &accessor,
- std::vector<unsigned int> &dof_indices)
+ std::vector<types::global_dof_index> &dof_indices)
{
// no caching for
// hp::DoFHandler
accessor.get_fe().dofs_per_vertex * GeometryInfo<dim>::vertices_per_cell),
ExcMessage ("Cell must either be active, or all DoFs must be in vertices"));
- unsigned int *cache = &accessor.dof_handler->levels[accessor.level()]
+ types::global_dof_index *cache = &accessor.dof_handler->levels[accessor.level()]
->cell_dof_indices_cache[accessor.present_index *
accessor.get_fe().dofs_per_cell];
for ( ; local_values_begin != local_values_end; ++local_values_begin, ++cache)
typename BaseClass::ExcVectorDoesNotMatch());
const unsigned int dofs_per_cell = accessor.get_fe().dofs_per_cell;
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
get_dof_indices (accessor, local_dof_indices);
for (unsigned int i=0; i<dofs_per_cell; ++i, ++local_values_begin)
accessor.get_fe().dofs_per_vertex * GeometryInfo<dim>::vertices_per_cell),
ExcMessage ("Cell must either be active, or all DoFs must be in vertices"));
- unsigned int *cache = &accessor.dof_handler->levels[accessor.level()]
+ types::global_dof_index *cache = &accessor.dof_handler->levels[accessor.level()]
->cell_dof_indices_cache[accessor.present_index *
accessor.get_fe().dofs_per_cell];
constraints.get_dof_values(values, *cache, local_values_begin,
typename BaseClass::ExcVectorDoesNotMatch());
const unsigned int dofs_per_cell = accessor.get_fe().dofs_per_cell;
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
get_dof_indices (accessor, local_dof_indices);
constraints.get_dof_values (values, local_dof_indices.begin(),
accessor.get_fe().dofs_per_vertex * GeometryInfo<dim>::vertices_per_cell),
ExcMessage ("Cell must either be active, or all DoFs must be in vertices"));
- unsigned int *cache = &accessor.dof_handler->levels[accessor.level()]
+ types::global_dof_index *cache = &accessor.dof_handler->levels[accessor.level()]
->cell_dof_indices_cache[accessor.present_index * accessor.get_fe().dofs_per_cell];
for (unsigned int i=0; i<accessor.get_fe().dofs_per_cell; ++i, ++cache)
values(*cache) = local_values(i);
// implemented
const unsigned int dofs_per_cell = accessor.get_fe().dofs_per_cell;
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
get_dof_indices (accessor, local_dof_indices);
for (unsigned int i=0; i<dofs_per_cell; ++i)
const unsigned int n_dofs = local_source_end - local_source_begin;
- unsigned int * dofs = &accessor.dof_handler->levels[accessor.level()]
+ types::global_dof_index * dofs = &accessor.dof_handler->levels[accessor.level()]
->cell_dof_indices_cache[accessor.present_index * n_dofs];
// distribute cell vector
//TODO[WB/MK]: This function could me made more efficient because it allocates memory, which could be avoided by passing in another argument as a scratch array. This should be fixed eventually
// get indices of dofs
- std::vector<unsigned int> dofs (n_dofs);
+ std::vector<types::global_dof_index> dofs (n_dofs);
accessor.get_dof_indices (dofs);
// distribute cell vector
const unsigned int n_dofs = local_source_end - local_source_begin;
- unsigned int * dofs = &accessor.dof_handler->levels[accessor.level()]
+ types::global_dof_index * dofs = &accessor.dof_handler->levels[accessor.level()]
->cell_dof_indices_cache[accessor.present_index * n_dofs];
// distribute cell vector
//TODO[WB/MK]: This function could me made more efficient because it allocates memory, which could be avoided by passing in another argument as a scratch array. This should be fixed eventually
// get indices of dofs
- std::vector<unsigned int> dofs (n_dofs);
+ std::vector<types::global_dof_index> dofs (n_dofs);
accessor.get_dof_indices (dofs);
// distribute cell vector
const unsigned int n_dofs = local_source.m();
- unsigned int * dofs = &accessor.dof_handler->levels[accessor.level()]
+ types::global_dof_index * dofs = &accessor.dof_handler->levels[accessor.level()]
->cell_dof_indices_cache[accessor.present_index * n_dofs];
// distribute cell matrix
//TODO[WB/MK]: This function could me made more efficient because it allocates memory, which could be avoided by passing in another argument as a scratch array.
// get indices of dofs
- std::vector<unsigned int> dofs (n_dofs);
+ std::vector<types::global_dof_index> dofs (n_dofs);
accessor.get_dof_indices (dofs);
// distribute cell matrix
ExcMessage ("Cell must either be active, or all DoFs must be in vertices"));
const unsigned int n_dofs = accessor.get_fe().dofs_per_cell;
- unsigned int * dofs = &accessor.dof_handler->levels[accessor.level()]
+ types::global_dof_index * dofs = &accessor.dof_handler->levels[accessor.level()]
->cell_dof_indices_cache[accessor.present_index * n_dofs];
// distribute cell matrices
//TODO[WB/MK]: This function could me made more efficient because it allocates memory, which could be avoided by passing in another argument as a scratch array.
// get indices of dofs
- std::vector<unsigned int> dofs (n_dofs);
+ std::vector<types::global_dof_index> dofs (n_dofs);
accessor.get_dof_indices (dofs);
// distribute cell matrix and vector
template<class DH>
inline
-void DoFCellAccessor<DH>::get_mg_dof_indices (std::vector<unsigned int>& dof_indices) const {
+void DoFCellAccessor<DH>::get_mg_dof_indices (std::vector<types::global_dof_index>& dof_indices) const {
DoFAccessor<dim, DH>::get_mg_dof_indices (this->level (), dof_indices);
}