* in the standard local
* numbering of DoFAccessor.
*/
- unsigned int renumber (const unsigned int i) const;
+ types::global_dof_index renumber (const types::global_dof_index i) const;
/**
* The number of base elements.
* ordering. Filled by
* initialize().
*/
- std::vector<unsigned int> local_renumbering;
+ std::vector<types::global_dof_index> local_renumbering;
};
inline
-unsigned int BlockInfo::renumber (const unsigned int i) const
+types::global_dof_index BlockInfo::renumber (const types::global_dof_index i) const
{
AssertIndexRange(i, local_renumbering.size());
return local_renumbering[i];
* the renumbering vector.
*/
template <int dim, int spacedim, class ITERATOR, class ENDITERATOR>
- unsigned int
+ types::global_dof_index
compute_block_wise (std::vector<types::global_dof_index> &new_dof_indices,
const ITERATOR &start,
const ENDITERATOR &end);
template<int dim, int spacedim>
void compute_block_renumbering (
const FiniteElement<dim,spacedim> &fe,
- std::vector<unsigned int> &renumbering,
+ std::vector<types::global_dof_index> &renumbering,
std::vector<types::global_dof_index> &block_data,
bool return_start_indices = true);
types::global_dof_index next_free_index = 0;
for (unsigned int block=0; block<fe_collection.n_blocks(); ++block)
{
- const typename std::vector<unsigned int>::const_iterator
+ const typename std::vector<types::global_dof_index>::const_iterator
begin_of_component = block_to_dof_map[block].begin(),
end_of_component = block_to_dof_map[block].end();
next_free_index = shifts[block];
- for (typename std::vector<unsigned int>::const_iterator
+ for (typename std::vector<types::global_dof_index>::const_iterator
dof_index = begin_of_component;
dof_index != end_of_component; ++dof_index)
{
void
count_dofs_per_block (const DH &dof_handler,
std::vector<types::global_dof_index> &dofs_per_block,
- const std::vector<types::global_dof_index> &target_block_)
+ const std::vector<unsigned int> &target_block_)
{
- std::vector<types::global_dof_index> target_block = target_block_;
+ std::vector<unsigned int> target_block = target_block_;
const dealii::hp::FECollection<DH::dimension,DH::space_dimension>
fe_collection (dof_handler.get_fe());
DoFTools::count_dofs_per_block<DoFHandler<deal_II_dimension> > (
const DoFHandler<deal_II_dimension>&,
std::vector<types::global_dof_index>&,
- const std::vector<types::global_dof_index> &);
+ const std::vector<unsigned int> &);
template
void
DoFTools::count_dofs_per_block<hp::DoFHandler<deal_II_dimension> > (
const hp::DoFHandler<deal_II_dimension>&,
std::vector<types::global_dof_index>&,
- const std::vector<types::global_dof_index> &);
+ const std::vector<unsigned int> &);
template
void
DoFTools::count_dofs_per_block<MGDoFHandler<deal_II_dimension> > (
const MGDoFHandler<deal_II_dimension>&,
std::vector<types::global_dof_index>&,
- const std::vector<types::global_dof_index> &);
+ const std::vector<unsigned int> &);
template
void
DoFTools::count_dofs_per_block<DoFHandler<deal_II_dimension,deal_II_dimension+1> > (
const DoFHandler<deal_II_dimension,deal_II_dimension+1>&,
std::vector<types::global_dof_index>&,
- const std::vector<types::global_dof_index> &);
+ const std::vector<unsigned int> &);
template
void
DoFTools::count_dofs_per_block<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> > (
const hp::DoFHandler<deal_II_dimension,deal_II_dimension+1>&,
std::vector<types::global_dof_index>&,
- const std::vector<types::global_dof_index> &);
+ const std::vector<unsigned int> &);
template
void
DoFTools::count_dofs_per_block<MGDoFHandler<deal_II_dimension,deal_II_dimension+1> > (
const MGDoFHandler<deal_II_dimension,deal_II_dimension+1>&,
std::vector<types::global_dof_index>&,
- const std::vector<types::global_dof_index> &);
+ const std::vector<unsigned int> &);
#endif
DoFTools::count_dofs_per_block<DoFHandler<1,3> > (
const DoFHandler<1,3>&,
std::vector<types::global_dof_index>&,
- const std::vector<types::global_dof_index> &);
+ const std::vector<unsigned int> &);
template
void
DoFTools::count_dofs_per_block<hp::DoFHandler<1,3> > (
const hp::DoFHandler<1,3>&,
std::vector<types::global_dof_index>&,
- const std::vector<types::global_dof_index> &);
+ const std::vector<unsigned int> &);
template
void
DoFTools::count_dofs_per_block<MGDoFHandler<1,3> > (
const MGDoFHandler<1,3>&,
std::vector<types::global_dof_index>&,
- const std::vector<types::global_dof_index> &);
+ const std::vector<unsigned int> &);
#endif
template<int dim, int spacedim>
void compute_block_renumbering (
const FiniteElement<dim,spacedim> &element,
- std::vector<unsigned int> &renumbering,
- std::vector<unsigned int> &block_data,
+ std::vector<types::global_dof_index> &renumbering,
+ std::vector<types::global_dof_index> &block_data,
bool return_start_indices)
{
Assert(renumbering.size() == element.dofs_per_cell,
//TODO:[GK] This does not work for a single RT
for (unsigned int i=0; i<element.dofs_per_cell; ++i)
{
- std::pair<unsigned int, unsigned int>
+ std::pair<types::global_dof_index, types::global_dof_index>
indices = element.system_to_block_index(i);
renumbering[i] = start_indices[indices.first]
+indices.second;
template
void compute_block_renumbering (
const FiniteElement<deal_II_dimension,deal_II_space_dimension>& ,
- std::vector<unsigned int>&, std::vector<unsigned int>&, bool);
+ std::vector<types::global_dof_index>&, std::vector<types::global_dof_index>&, bool);
template
void compute_projection_matrices<deal_II_dimension, double, deal_II_space_dimension>
count_dofs_per_block (
const DH &dof_handler,
std::vector<std::vector<types::global_dof_index> > &dofs_per_block,
- std::vector<types::global_dof_index> target_block)
+ std::vector<unsigned int> target_block)
{
const FiniteElement<DH::dimension,DH::space_dimension> &fe = dof_handler.get_fe();
const unsigned int n_blocks = fe.n_blocks();
std::vector<types::global_dof_index>);
template void count_dofs_per_block (
const DoFHandler<deal_II_dimension>&, std::vector<std::vector<types::global_dof_index> >&,
- std::vector<types::global_dof_index>);
+ std::vector<unsigned int>);
template void count_dofs_per_block (
const MGDoFHandler<deal_II_dimension>&, std::vector<std::vector<types::global_dof_index> >&,
- std::vector<types::global_dof_index>);
+ std::vector<unsigned int>);
#if deal_II_dimension > 1
template void make_boundary_list(