}
+
/*------------------------ Cell iterator functions ------------------------*/
template <int dim, int spacedim>
}
-
-
//------------------------------------------------------------------
}
-
template <>
unsigned int DoFHandler<1,3>::n_boundary_dofs () const
{
// vertices at all, I can't think
// of a finite element that would
// make that necessary...
- Table<2,std_cxx1x::shared_ptr<dealii::internal::hp::DoFIdentities> >
+ Table<2,std_cxx1x::shared_ptr<internal::hp::DoFIdentities> >
vertex_dof_identities (get_fe().size(),
get_fe().size());
++vertex_index)
{
const unsigned int n_active_fe_indices
- = dealii::internal::DoFAccessor::Implementation::
+ = internal::DoFAccessor::Implementation::
n_active_vertex_fe_indices (*this, vertex_index);
if (n_active_fe_indices > 1)
{
const unsigned int
first_fe_index
- = dealii::internal::DoFAccessor::Implementation::
+ = internal::DoFAccessor::Implementation::
nth_active_vertex_fe_index (*this, vertex_index, 0);
// loop over all the
{
const unsigned int
other_fe_index
- = dealii::internal::DoFAccessor::Implementation::
+ = internal::DoFAccessor::Implementation::
nth_active_vertex_fe_index (*this, vertex_index, f);
// make sure the
// entry in the
// equivalence
// table exists
- dealii::internal::hp::ensure_existence_of_dof_identities<0>
+ internal::hp::ensure_existence_of_dof_identities<0>
(get_fe()[first_fe_index],
get_fe()[other_fe_index],
vertex_dof_identities[first_fe_index][other_fe_index]);
// lower, to avoid
// circular
// reasoning.
- dealii::internal::hp::DoFIdentities &identities
+ internal::hp::DoFIdentities &identities
= *vertex_dof_identities[first_fe_index][other_fe_index];
for (unsigned int i=0; i<identities.size(); ++i)
{
const unsigned int lower_dof_index
- = dealii::internal::DoFAccessor::Implementation::
+ = internal::DoFAccessor::Implementation::
get_vertex_dof_index (*this,
vertex_index,
first_fe_index,
identities[i].first);
const unsigned int higher_dof_index
- = dealii::internal::DoFAccessor::Implementation::
+ = internal::DoFAccessor::Implementation::
get_vertex_dof_index (*this,
vertex_index,
other_fe_index,
}
+
template <>
void
DoFHandler<1,1>::
// then allocate space for all
// the other tables
- dealii::internal::hp::DoFHandler::Implementation::reserve_space (*this);
+ internal::hp::DoFHandler::Implementation::reserve_space (*this);
// Clear user flags because we will
// need them. But first we save
for (; cell != endc; ++cell)
next_free_dof
- = dealii::internal::hp::DoFHandler::Implementation::template distribute_dofs_on_cell<spacedim> (cell,
+ = internal::hp::DoFHandler::Implementation::template distribute_dofs_on_cell<spacedim> (cell,
next_free_dof);
number_cache.n_global_dofs = next_free_dof;
// finally, do the renumbering
// and set the number of actually
// used dof indices
- renumber_dofs_internal (new_dof_indices, dealii::internal::int2type<dim>());
+ renumber_dofs_internal (new_dof_indices, internal::int2type<dim>());
// now set the elements of the
// number cache appropriately
}
#endif
- renumber_dofs_internal (new_numbers, dealii::internal::int2type<dim>());
+ renumber_dofs_internal (new_numbers, internal::int2type<dim>());
}
void
DoFHandler<dim,spacedim>::
renumber_dofs_internal (const std::vector<unsigned int> &new_numbers,
- dealii::internal::int2type<0>)
+ internal::int2type<0>)
{
Assert (new_numbers.size() == n_dofs(), ExcRenumberingIncomplete());
++vertex_index)
{
const unsigned int n_active_fe_indices
- = dealii::internal::DoFAccessor::Implementation::
+ = internal::DoFAccessor::Implementation::
n_active_vertex_fe_indices (*this, vertex_index);
for (unsigned int f=0; f<n_active_fe_indices; ++f)
{
const unsigned int fe_index
- = dealii::internal::DoFAccessor::Implementation::
+ = internal::DoFAccessor::Implementation::
nth_active_vertex_fe_index (*this, vertex_index, f);
for (unsigned int d=0; d<(*finite_elements)[fe_index].dofs_per_vertex; ++d)
{
const unsigned int vertex_dof_index
- = dealii::internal::DoFAccessor::Implementation::
+ = internal::DoFAccessor::Implementation::
get_vertex_dof_index(*this,
vertex_index,
fe_index,
d);
- dealii::internal::DoFAccessor::Implementation::
+ internal::DoFAccessor::Implementation::
set_vertex_dof_index (*this,
vertex_index,
fe_index,
void
DoFHandler<dim,spacedim>::
renumber_dofs_internal (const std::vector<unsigned int> &new_numbers,
- dealii::internal::int2type<1>)
+ internal::int2type<1>)
{
Assert (new_numbers.size() == n_dofs(), ExcRenumberingIncomplete());
}
-
//TODO: Merge the following three functions -- they are identical
template<>
void
DoFHandler<2,2>::
renumber_dofs_internal (const std::vector<unsigned int> &new_numbers,
- dealii::internal::int2type<2>)
+ internal::int2type<2>)
{
const unsigned int dim = 2;
const unsigned int spacedim = 2;
void
DoFHandler<2,3>::
renumber_dofs_internal (const std::vector<unsigned int> &new_numbers,
- dealii::internal::int2type<2>)
+ internal::int2type<2>)
{
const unsigned int dim = 2;
const unsigned int spacedim = 3;
void
DoFHandler<3,3>::
renumber_dofs_internal (const std::vector<unsigned int> &new_numbers,
- dealii::internal::int2type<2>)
+ internal::int2type<2>)
{
const unsigned int dim = 3;
const unsigned int spacedim = 3;
void
DoFHandler<3,3>::
renumber_dofs_internal (const std::vector<unsigned int> &new_numbers,
- dealii::internal::int2type<3>)
+ internal::int2type<3>)
{
const unsigned int dim = 3;
const unsigned int spacedim = 3;
DoFHandler<dim, spacedim>::max_couplings_between_dofs () const
{
Assert (finite_elements != 0, ExcNoFESelected());
- return dealii::internal::hp::DoFHandler::Implementation::max_couplings_between_dofs (*this);
+ return internal::hp::DoFHandler::Implementation::max_couplings_between_dofs (*this);
}
// Create sufficiently many
// hp::DoFLevels.
while (levels.size () < tria->n_levels ())
- levels.push_back (new dealii::internal::hp::DoFLevel<dim>);
+ levels.push_back (new internal::hp::DoFLevel<dim>);
// then make sure that on each
// level we have the appropriate
}
-
template <>
void DoFHandler<1,3>::pre_refinement_action ()
{
// it is appended to the DoFHandler
// levels.
if (levels.size () < tria->n_levels ())
- levels.push_back (new dealii::internal::hp::DoFLevel<dim>);
+ levels.push_back (new internal::hp::DoFLevel<dim>);
// Coarsening can lead to the loss
// of levels. Hence remove them.
}
- template <int dim, int spacedim>
- template <int structdim>
- unsigned int
- DoFHandler<dim,spacedim>::get_dof_index (const unsigned int,
- const unsigned int,
- const unsigned int,
- const unsigned int) const
- {
- Assert (false, ExcNotImplemented());
- return numbers::invalid_unsigned_int;
- }
-
-
- template <int dim, int spacedim>
- template <int structdim>
- void
- DoFHandler<dim,spacedim>::set_dof_index (const unsigned int,
- const unsigned int,
- const unsigned int,
- const unsigned int,
- const unsigned int) const
- {
- Assert (false, ExcNotImplemented());
- }
-
-
template<int dim, int spacedim>
void DoFHandler<dim,spacedim>::clear_space ()
{