#include <deal.II/base/config.h>
+#include <deal.II/base/types.h>
#include <deal.II/lac/constraint_matrix.h>
#include <deal.II/dofs/dof_accessor.h>
#include <deal.II/dofs/dof_levels.h>
#include <deal.II/grid/tria_iterator.templates.h>
#include <vector>
+#include <limits>
DEAL_II_NAMESPACE_OPEN
Assert (pointer <= &dof_handler.vertex_dofs.back(), ExcInternalError());
// a fe index is always small
- Assert((*pointer)<numeric_limits<unsigned int>::max(), ExcInternalError());
+ Assert((*pointer)<std::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,
// we can't find a set for this
// particular fe_index
const unsigned int starting_offset = dof_handler.vertex_dofs_offsets[vertex_index];
- const types:global_dof_index *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());
- Assert((*pointer)<numeric_limits<unsigned int>::max(), ExcInternalError());
+ Assert((*pointer)<std::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,
{
Assert (pointer <= &dof_handler.vertex_dofs.back(), ExcInternalError());
- Assert((*pointer)<numeric_limits<unsigned int>::max(), ExcInternalError());
+ Assert((*pointer)<std::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)
{
Assert (pointer <= &dof_handler.vertex_dofs.back(), ExcInternalError());
- Assert((*pointer)<numeric_limits<unsigned int>::max(), ExcInternalError());
+ Assert((*pointer)<std::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(),
{
Assert (pointer <= &dof_handler.vertex_dofs.back(), ExcInternalError());
- Assert((*pointer)<numeric_limits<unsigned int>::max(), ExcInternalError());
+ Assert((*pointer)<std::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(),
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 ());
for (unsigned int vertex=0; vertex<2; ++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]);
for (unsigned int d=0; d<dofs_per_line; ++d, ++index)
- accessor.dof_index(d, local_dof_indices[index]);
+ accessor.dof_index(d, dof_indices[index]);
Assert (index == dofs_per_cell,
ExcInternalError());
accessor.line(line)->set_dof_index(accessor.dof_handler->get_fe().
adjust_line_dof_index_for_line_orientation(d,
accessor.line_orientation(line)),
- local_dof_indices[index]);
+ dof_indices[index]);
// now copy dof numbers into the face. for
// faces with the wrong orientation, we
// have already made sure that we're ok by
accessor.face_orientation(quad),
accessor.face_flip(quad),
accessor.face_rotation(quad)),
- local_dof_indices[index]);
+ dof_indices[index]);
for (unsigned int d=0; d<dofs_per_hex; ++d, ++index)
- accessor.set_dof_index(d, local_dof_indices[index]);
+ accessor.set_dof_index(d, dof_indices[index]);
Assert (index == dofs_per_cell,
ExcInternalError());