std::vector<unsigned int>
invert_permutation (const std::vector<unsigned int> &permutation);
+ /**
+ * Given a permutation vector (i.e. a
+ * vector $p_0\ldots p_{N-1}$ where each
+ * $p_i\in [0,N)$ and $p_i\neq p_j$ for
+ * $i\neq j$), produce the reverse
+ * permutation $q_i=N-1-p_i$.
+ */
+ std::vector<unsigned long long int>
+ reverse_permutation (const std::vector<unsigned long long int> &permutation);
+
+ /**
+ * Given a permutation vector (i.e. a
+ * vector $p_0\ldots p_{N-1}$ where each
+ * $p_i\in [0,N)$ and $p_i\neq p_j$ for
+ * $i\neq j$), produce the inverse
+ * permutation $q_0\ldots q_{N-1}$ so that
+ * $q_{p_i}=p_{q_i}=i$.
+ */
+ std::vector<unsigned long long int>
+ invert_permutation (const std::vector<unsigned long long int> &permutation);
+
/**
* A namespace for utility functions that
* probe system properties.
*/
template <int dim, int spacedim, class ITERATOR, class ENDITERATOR>
unsigned int
- compute_block_wise (std::vector<unsigned int> &new_dof_indices,
+ compute_block_wise (std::vector<types::global_dof_index> &new_dof_indices,
const ITERATOR &start,
const ENDITERATOR &end);
const DH &dof_handler,
const unsigned int level,
const std::vector<bool> &selected_dofs = std::vector<bool>(),
- unsigned int offset = 0);
+ types::global_dof_index offset = 0);
/**
* Create an incidence matrix that
void
count_dofs_per_block (const DH &dof,
std::vector<types::global_dof_index> &dofs_per_block,
- const std::vector<types::global_dof_index> &target_block
- = std::vector<types::global_dof_index>());
+ const std::vector<unsigned int> &target_block
+ = std::vector<unsigned int>());
/**
* @deprecated See the previous
void
map_dofs_to_support_points (const Mapping<dim,spacedim> &mapping,
const DoFHandler<dim,spacedim> &dof_handler,
- std::map<unsigned int, Point<spacedim> > &support_points);
+ std::map<types::global_dof_index, Point<spacedim> > &support_points);
/**
* Same as the previous function but for the hp case.
void
map_dofs_to_support_points (const dealii::hp::MappingCollection<dim,spacedim> &mapping,
const hp::DoFHandler<dim,spacedim> &dof_handler,
- std::map<unsigned int, Point<spacedim> > &support_points);
+ std::map<types::global_dof_index, Point<spacedim> > &support_points);
/**
const double inner_radius = .25,
const double outer_radius = .5,
const double L = .5,
- const unsigned int repetition = 1,
+ const size_type repetition = 1,
const bool colorize = false);
/**
* Return the number of degrees of freedom
* located on the boundary.
*/
- unsigned int n_boundary_dofs () const;
+ types::global_dof_index n_boundary_dofs () const;
/**
* Return the number of degrees
/**
* Control values set by <tt>MA47ID</tt>.
*/
- double CNTL[2];
- size_type ICNTL[7];
+ double CNTL[2];
+ unsigned int ICNTL[7];
/**
* Info field filled by the MA47
* Call the <tt>ma47id</tt> function
* with the given args.
*/
- void call_ma47id (double *CNTL,
- size_type *ICNTL);
+ void call_ma47id (double *CNTL,
+ unsigned int *ICNTL);
/**
* Call the <tt>ma47ad</tt> function
* Call the <tt>ma47bd</tt> function
* with the given args.
*/
- void call_ma47bd (const size_type *n_rows,
- const size_type *n_nonzero_elements,
- const size_type *column_numbers,
- double *A,
- const size_type *LA,
- size_type *IW,
- const size_type *LIW,
- const size_type *KEEP,
- const double *CNTL,
- const size_type *ICNTL,
- size_type *IW1,
- int *INFO);
+ void call_ma47bd (const size_type *n_rows,
+ const size_type *n_nonzero_elements,
+ const size_type *column_numbers,
+ double *A,
+ const size_type *LA,
+ size_type *IW,
+ const size_type *LIW,
+ const size_type *KEEP,
+ const double *CNTL,
+ const unsigned int *ICNTL,
+ size_type *IW1,
+ int *INFO);
/**
* Call the <tt>ma47bd</tt> function
* with the given args.
*/
- void call_ma47cd (const size_type *n_rows,
- const double *A,
- const size_type *LA,
- const size_type *IW,
- const size_type *LIW,
- double *rhs_and_solution,
- size_type *IW1,
- const size_type *ICNTL);
+ void call_ma47cd (const size_type *n_rows,
+ const double *A,
+ const size_type *LA,
+ const size_type *IW,
+ const size_type *LIW,
+ double *rhs_and_solution,
+ size_type *IW1,
+ const unsigned int *ICNTL);
};
selected.end(),
true);
- const size_type n_inverses_per_thread = std::max(n_inverses / n_threads, 1U);
+ const size_type n_inverses_per_thread = std::max(n_inverses / n_threads,
+ static_cast<size_type> (1U));
// set up start and end index
// for each of the
selected.end(),
true);
- const size_type n_inverses_per_block = std::max(n_inverses / n_blocks, 1U);
+ const size_type n_inverses_per_block = std::max(n_inverses / n_blocks,
+ static_cast<size_type> (1U));
// precompute the splitting points
std::vector<std::pair<size_type, size_type> > intervals (n_blocks);
const size_type sz = size();
char buf[16];
- std::sprintf(buf, "%d", sz);
+#ifdef DEAL_II_USE_LARGE_INDEX_TYPE
+ std::sprintf(buf, "%llu", sz);
+#else
+ std::sprintf(buf, "%u", sz);
+#endif
std::strcat(buf, "\n[");
out.write(buf, std::strlen(buf));
void
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<types::global_dof_index>());
+ std::vector<unsigned int> target_block = std::vector<unsigned int>());
/**
* Count the dofs component-wise
template <int dim, typename number, int spacedim>
void
reinit_vector (const dealii::DoFHandler<dim,spacedim> &mg_dof,
- std::vector<types::global_dof_index> target_component,
+ std::vector<unsigned int> target_component,
MGLevelObject<BlockVector<number> > &v)
{
const unsigned int n_blocks = mg_dof.get_fe().n_blocks();
/**
* Start index of each block.
*/
- std::vector<unsigned int> block_start;
+ std::vector<types::global_dof_index> block_start;
/**
* Start index of each block on
* all levels.
*/
- std::vector<std::vector<unsigned int> > mg_block_start;
+ std::vector<std::vector<types::global_dof_index> > mg_block_start;
/**
* Call build_matrices()
//the block back to dst.
const unsigned int n_blocks =
*std::max_element(target_component.begin(), target_component.end()) + 1;
- std::vector<unsigned int> dofs_per_block (n_blocks);
+ std::vector<types::global_dof_index> dofs_per_block (n_blocks);
DoFTools::count_dofs_per_block (mg_dof_handler, dofs_per_block, target_component);
BlockVector<number> tmp;
tmp.reinit(n_blocks);
return out;
}
+ std::vector<unsigned long long int>
+ reverse_permutation (const std::vector<unsigned long long int> &permutation)
+ {
+ const unsigned long long int n = permutation.size();
+
+ std::vector<unsigned long long int> out (n);
+ for (unsigned long long int i=0; i<n; ++i)
+ out[i] = n - 1 - permutation[i];
+
+ return out;
+ }
+
+
+
+ std::vector<unsigned long long int>
+ invert_permutation (const std::vector<unsigned long int> &permutation)
+ {
+ const unsigned long long int n = permutation.size();
+
+ std::vector<unsigned long long int> out (n, numbers::invalid_unsigned_int);
+
+ for (unsigned long long int i=0; i<n; ++i)
+ {
+ Assert (permutation[i] < n, ExcIndexRange (permutation[i], 0, n));
+ out[permutation[i]] = i;
+ }
+
+ // check that we have actually reached
+ // all indices
+ for (unsigned long long int i=0; i<n; ++i)
+ Assert (out[i] != numbers::invalid_unsigned_int,
+ ExcMessage ("The given input permutation had duplicate entries!"));
+
+ return out;
+ }
+
template <typename Integer>
std::vector<Integer>
types::global_dof_index next_free_index = 0;
for (unsigned int component=0; component<fe_collection.n_components(); ++component)
{
- const typename std::vector<unsigned int>::const_iterator
+ const typename std::vector<types::global_dof_index>::const_iterator
begin_of_component = component_to_dof_map[component].begin(),
end_of_component = component_to_dof_map[component].end();
next_free_index = shifts[component];
- 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)
{
(DoFHandler<deal_II_dimension,deal_II_space_dimension>&,
const bool,
const bool,
- const std::vector<unsigned int>&);
+ const std::vector<types::global_dof_index>&);
template
void
compute_Cuthill_McKee<DoFHandler<deal_II_dimension,deal_II_space_dimension> >
- (std::vector<unsigned int>&,
+ (std::vector<types::global_dof_index>&,
const DoFHandler<deal_II_dimension,deal_II_space_dimension>&,
const bool,
const bool,
- const std::vector<unsigned int>&);
+ const std::vector<types::global_dof_index>&);
template
void component_wise<deal_II_dimension,deal_II_space_dimension>
(hp::DoFHandler<deal_II_dimension>&,
const bool,
const bool,
- const std::vector<unsigned int>&);
+ const std::vector<types::global_dof_index>&);
template
void
compute_Cuthill_McKee<hp::DoFHandler<deal_II_dimension> >
- (std::vector<unsigned int>&,
+ (std::vector<types::global_dof_index>&,
const hp::DoFHandler<deal_II_dimension>&,
const bool,
const bool,
- const std::vector<unsigned int>&);
+ const std::vector<types::global_dof_index>&);
template
void component_wise
template void
compute_cell_wise<DoFHandler<deal_II_dimension> >
- (std::vector<unsigned int>&, std::vector<unsigned int>&,
+ (std::vector<types::global_dof_index>&, std::vector<types::global_dof_index>&,
const DoFHandler<deal_II_dimension>&,
const std::vector<DoFHandler<deal_II_dimension>::active_cell_iterator>&);
template void
compute_cell_wise<DoFHandler<deal_II_dimension> >
- (std::vector<unsigned int>&, std::vector<unsigned int>&,
+ (std::vector<types::global_dof_index>&, std::vector<types::global_dof_index>&,
const DoFHandler<deal_II_dimension>&, unsigned int,
const std::vector<DoFHandler<deal_II_dimension>::level_cell_iterator>&);
template void
compute_downstream<DoFHandler<deal_II_dimension> >
- (std::vector<unsigned int>&,std::vector<unsigned int>&,
+ (std::vector<types::global_dof_index>&,std::vector<types::global_dof_index>&,
const DoFHandler<deal_II_dimension>&, const Point<deal_II_dimension>&,
const bool);
template
void
compute_clockwise_dg<DoFHandler<deal_II_dimension> >
- (std::vector<unsigned int>&, const DoFHandler<deal_II_dimension>&,
+ (std::vector<types::global_dof_index>&, const DoFHandler<deal_II_dimension>&,
const Point<deal_II_dimension>&, const bool);
// Renumbering for hp::DoFHandler
template void
compute_cell_wise<hp::DoFHandler<deal_II_dimension> >
- (std::vector<unsigned int>&, std::vector<unsigned int>&,
+ (std::vector<types::global_dof_index>&, std::vector<types::global_dof_index>&,
const hp::DoFHandler<deal_II_dimension>&,
const std::vector<hp::DoFHandler<deal_II_dimension>::active_cell_iterator>&);
template void
compute_downstream<hp::DoFHandler<deal_II_dimension> >
- (std::vector<unsigned int>&,std::vector<unsigned int>&,
+ (std::vector<types::global_dof_index>&,std::vector<types::global_dof_index>&,
const hp::DoFHandler<deal_II_dimension>&,
const Point<deal_II_dimension>&,
const bool);
template
void
compute_clockwise_dg<hp::DoFHandler<deal_II_dimension> >
- (std::vector<unsigned int>&,
+ (std::vector<types::global_dof_index>&,
const hp::DoFHandler<deal_II_dimension>&,
const Point<deal_II_dimension>&,
const bool);
template
void
compute_random<DoFHandler<deal_II_dimension> >
- (std::vector<unsigned int>&,
+ (std::vector<types::global_dof_index>&,
const DoFHandler<deal_II_dimension> &);
template
template
void
compute_sort_selected_dofs_back<DoFHandler<deal_II_dimension> >
- (std::vector<unsigned int>&,
+ (std::vector<types::global_dof_index>&,
const DoFHandler<deal_II_dimension> &,
const std::vector<bool> &);
template
void
compute_sort_selected_dofs_back<MGDoFHandler<deal_II_dimension> >
- (std::vector<unsigned int>&,
+ (std::vector<types::global_dof_index>&,
const MGDoFHandler<deal_II_dimension> &,
const std::vector<bool> &,
const unsigned int);
template
void
compute_random<hp::DoFHandler<deal_II_dimension> >
- (std::vector<unsigned int>&,
+ (std::vector<types::global_dof_index>&,
const hp::DoFHandler<deal_II_dimension> &);
template
template
void
compute_sort_selected_dofs_back<hp::DoFHandler<deal_II_dimension> >
- (std::vector<unsigned int>&,
+ (std::vector<types::global_dof_index>&,
const hp::DoFHandler<deal_II_dimension> &,
const std::vector<bool> &);
(DoFHandler<deal_II_dimension>&,
const unsigned int,
const bool,
- const std::vector<unsigned int>&);
+ const std::vector<types::global_dof_index>&);
template
void Cuthill_McKee<MGDoFHandler<deal_II_dimension> >
(MGDoFHandler<deal_II_dimension>&,
const unsigned int,
const bool,
- const std::vector<unsigned int>&);
+ const std::vector<types::global_dof_index>&);
\} // namespace DoFRenumbering
#endif
local_selected_dofs[i] = component_mask[local_component_asssociation[i]];
// then loop over all cells and do work
- std::vector<unsigned int> indices(fe.dofs_per_cell);
+ std::vector<types::global_dof_index> indices(fe.dofs_per_cell);
typename DH::level_cell_iterator c;
for (c = dof.begin(level) ; c != dof.end(level) ; ++ c)
{
void
resolve_components (const FiniteElement<dim,spacedim> &fe,
const std::vector<unsigned char> &dofs_by_component,
- const std::vector<unsigned int> &target_component,
+ const std::vector<types::global_dof_index> &target_component,
const bool only_once,
- std::vector<types::global_dof_index> &dofs_per_component,
+ std::vector<types::global_dof_index> &dofs_per_component,
unsigned int &component)
{
for (unsigned int b=0; b<fe.n_base_elements(); ++b)
void
resolve_components (const hp::FECollection<dim,spacedim> &fe_collection,
const std::vector<unsigned char> &dofs_by_component,
- const std::vector<unsigned int> &target_component,
+ const std::vector<types::global_dof_index> &target_component,
const bool only_once,
- std::vector<types::global_dof_index> &dofs_per_component,
+ std::vector<types::global_dof_index> &dofs_per_component,
unsigned int &component)
{
// assert that all elements in the collection have the same structure
const DH &dof_handler,
std::vector<types::global_dof_index> &dofs_per_component,
bool only_once,
- std::vector<unsigned int> target_component)
+ std::vector<types::global_dof_index> target_component)
{
const unsigned int n_components = dof_handler.get_fe().n_components();
void
count_dofs_per_block (const DH &dof_handler,
std::vector<types::global_dof_index> &dofs_per_block,
- const std::vector<unsigned int> &target_block_)
+ const std::vector<types::global_dof_index> &target_block_)
{
- std::vector<unsigned int> target_block = target_block_;
+ std::vector<types::global_dof_index> target_block = target_block_;
const dealii::hp::FECollection<DH::dimension,DH::space_dimension>
fe_collection (dof_handler.get_fe());
void
count_dofs_per_component (const DoFHandler<dim,spacedim> &dof_handler,
std::vector<types::global_dof_index> &dofs_per_component,
- std::vector<unsigned int> target_component)
+ std::vector<types::global_dof_index> target_component)
{
count_dofs_per_component (dof_handler, dofs_per_component,
false, target_component);
weights, weight_mapping);
// now compute the requested representation
- const unsigned int n_global_parm_dofs
+ const types::global_dof_index n_global_parm_dofs
= std::count_if (weight_mapping.begin(), weight_mapping.end(),
std::bind2nd (std::not_equal_to<int> (), -1));
// first construct the inverse mapping of weight_mapping
- std::vector<unsigned int> inverse_weight_mapping (n_global_parm_dofs,
+ std::vector<types::global_dof_index> inverse_weight_mapping (n_global_parm_dofs,
DoFHandler<dim,spacedim>::invalid_dof_index);
for (unsigned int i=0; i<weight_mapping.size(); ++i)
{
{
typename DH::level_cell_iterator cell;
typename DH::level_cell_iterator endc = dof_handler.end(level);
- std::vector<unsigned int> indices;
+ std::vector<types::global_dof_index> indices;
unsigned int i=0;
for (cell=dof_handler.begin(level); cell != endc; ++i, ++cell)
typename DH::level_cell_iterator cell;
typename DH::level_cell_iterator endc = dof_handler.end(level);
- std::vector<unsigned int> indices;
+ std::vector<types::global_dof_index> indices;
std::vector<bool> exclude;
for (cell=dof_handler.begin(level); cell != endc; ++cell)
typename DH::level_cell_iterator pcell = dof_handler.begin(level-1);
typename DH::level_cell_iterator endc = dof_handler.end(level-1);
- std::vector<unsigned int> indices;
+ std::vector<types::global_dof_index> indices;
std::vector<bool> exclude;
for (unsigned int block = 0; pcell != endc; ++pcell)
numbers::invalid_unsigned_int);
// Estimate for the number of dofs at this point
- std::vector<unsigned int> vertex_dof_count(dof_handler.get_tria().n_vertices(), 0);
+ std::vector<types::global_dof_index> vertex_dof_count(dof_handler.get_tria().n_vertices(), 0);
// Identify all vertices active on this level and remember some data
// about them
// into the sparsity pattern.
block_list.reinit(vertex_dof_count.size(), dof_handler.n_dofs(level), vertex_dof_count);
- std::vector<unsigned int> indices;
+ std::vector<types::global_dof_index> indices;
std::vector<bool> exclude;
for (cell=dof_handler.begin(level); cell != endc; ++cell)
DoFTools::make_boundary_sparsity_pattern<hp::DoFHandler<deal_II_dimension>,SP>
(const hp::DoFHandler<deal_II_dimension>& dof,
const FunctionMap<deal_II_dimension>::type &boundary_indicators,
- const std::vector<unsigned int> &dof_to_boundary_mapping,
+ const std::vector<types::global_dof_index> &dof_to_boundary_mapping,
SP &sparsity);
template void
template void
DoFTools::make_cell_patches<DoFHandler<deal_II_dimension>,SP>
- (SP&, const DoFHandler<deal_II_dimension>&, unsigned int, const std::vector<bool>&, unsigned int);
+ (SP&, const DoFHandler<deal_II_dimension>&, const unsigned int, const std::vector<bool>&, types::global_dof_index);
template void
DoFTools::make_cell_patches<MGDoFHandler<deal_II_dimension>,SP>
- (SP&, const MGDoFHandler<deal_II_dimension>&, unsigned int, const std::vector<bool>&, unsigned int);
+ (SP&, const MGDoFHandler<deal_II_dimension>&, const unsigned int, const std::vector<bool>&, types::global_dof_index);
#if deal_II_dimension > 1
template void
DoFTools::make_boundary_sparsity_pattern<DoFHandler<deal_II_dimension,deal_II_dimension+1>,SP>
(const DoFHandler<deal_II_dimension,deal_II_dimension+1>& dof,
- const std::vector<unsigned int> &,
+ const std::vector<types::global_dof_index> &,
SP &);
//template void
//DoFTools::make_boundary_sparsity_pattern<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1>,SP>
//(const hp::DoFHandler<deal_II_dimension,deal_II_dimension+1>& dof,
- // const std::vector<unsigned int> &,
+ // const std::vector<types::global_dof_index> &,
// SP &);
template void
DoFTools::make_boundary_sparsity_pattern<DoFHandler<deal_II_dimension,deal_II_dimension+1>,SP>
(const DoFHandler<deal_II_dimension,deal_II_dimension+1>& dof,
const FunctionMap<deal_II_dimension+1>::type &boundary_indicators,
- const std::vector<unsigned int> &dof_to_boundary_mapping,
+ const std::vector<types::global_dof_index> &dof_to_boundary_mapping,
SP &sparsity);
//template void
//DoFTools::make_boundary_sparsity_pattern<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1>,SP>
//(const hp::DoFHandler<deal_II_dimension,deal_II_dimension+1>& dof,
// const FunctionMap<deal_II_dimension+1>::type &boundary_indicators,
- // const std::vector<unsigned int> &dof_to_boundary_mapping,
+ // const std::vector<types::global_dof_index> &dof_to_boundary_mapping,
// SP &sparsity);
#endif
template void
DoFTools::make_boundary_sparsity_pattern<DoFHandler<1,3>,SP>
(const DoFHandler<1,3>& dof,
- const std::vector<unsigned int> &,
+ const std::vector<types::global_dof_index> &,
SP &);
//template void
//DoFTools::make_boundary_sparsity_pattern<hp::DoFHandler<1,3>,SP>
//(const hp::DoFHandler<1,3>& dof,
- // const std::vector<unsigned int> &,
+ // const std::vector<types::global_dof_index> &,
// SP &);
template void
DoFTools::make_boundary_sparsity_pattern<DoFHandler<1,3>,SP>
(const DoFHandler<1,3>& dof,
const FunctionMap<3>::type &boundary_indicators,
- const std::vector<unsigned int> &dof_to_boundary_mapping,
+ const std::vector<types::global_dof_index> &dof_to_boundary_mapping,
SP &sparsity);
//template void
//DoFTools::make_boundary_sparsity_pattern<hp::DoFHandler<1,3>,SP>
//(const hp::DoFHandler<1,3>& dof,
// const FunctionMap<3>::type &boundary_indicators,
- // const std::vector<unsigned int> &dof_to_boundary_mapping,
+ // const std::vector<types::global_dof_index> &dof_to_boundary_mapping,
// SP &sparsity);
#endif
void
DoFTools::count_dofs_per_component<DoFHandler<deal_II_dimension> > (
const DoFHandler<deal_II_dimension>&,
- std::vector<unsigned int>&, bool, std::vector<unsigned int>);
+ std::vector<types::global_dof_index>&, bool, std::vector<types::global_dof_index>);
template
void
DoFTools::count_dofs_per_component<hp::DoFHandler<deal_II_dimension> > (
const hp::DoFHandler<deal_II_dimension>&,
- std::vector<unsigned int>&, bool, std::vector<unsigned int>);
+ std::vector<types::global_dof_index>&, bool, std::vector<types::global_dof_index>);
#if deal_II_dimension < 3
void
DoFTools::count_dofs_per_component<DoFHandler<deal_II_dimension, deal_II_dimension+1> > (
const DoFHandler<deal_II_dimension, deal_II_dimension+1>&,
- std::vector<unsigned int>&, bool, std::vector<unsigned int>);
+ std::vector<types::global_dof_index>&, bool, std::vector<types::global_dof_index>);
template
void
DoFTools::count_dofs_per_component<hp::DoFHandler<deal_II_dimension, deal_II_dimension+1> > (
const hp::DoFHandler<deal_II_dimension, deal_II_dimension+1>&,
- std::vector<unsigned int>&, bool, std::vector<unsigned int>);
+ std::vector<types::global_dof_index>&, bool, std::vector<types::global_dof_index>);
template
void
void
DoFTools::count_dofs_per_component<DoFHandler<1,3> > (
const DoFHandler<1,3>&,
- std::vector<unsigned int>&, bool, std::vector<unsigned int>);
+ std::vector<types::global_dof_index>&, bool, std::vector<types::global_dof_index>);
template
void
DoFTools::count_dofs_per_component<hp::DoFHandler<1,3> > (
const hp::DoFHandler<1,3>&,
- std::vector<unsigned int>&, bool, std::vector<unsigned int>);
+ std::vector<types::global_dof_index>&, bool, std::vector<types::global_dof_index>);
template
void
void
DoFTools::count_dofs_per_block<DoFHandler<deal_II_dimension> > (
const DoFHandler<deal_II_dimension>&,
- std::vector<unsigned int>&,
- const std::vector<unsigned int> &);
+ std::vector<types::global_dof_index>&,
+ const std::vector<types::global_dof_index> &);
template
void
DoFTools::count_dofs_per_block<hp::DoFHandler<deal_II_dimension> > (
const hp::DoFHandler<deal_II_dimension>&,
- std::vector<unsigned int>&,
- const std::vector<unsigned int> &);
+ std::vector<types::global_dof_index>&,
+ const std::vector<types::global_dof_index> &);
template
void
DoFTools::count_dofs_per_block<MGDoFHandler<deal_II_dimension> > (
const MGDoFHandler<deal_II_dimension>&,
- std::vector<unsigned int>&,
- const std::vector<unsigned int> &);
+ std::vector<types::global_dof_index>&,
+ const std::vector<types::global_dof_index> &);
template
void
DoFTools::count_dofs_per_component<deal_II_dimension> (
const DoFHandler<deal_II_dimension>&,
- std::vector<unsigned int>&, std::vector<unsigned int>);
+ std::vector<types::global_dof_index>&, std::vector<types::global_dof_index>);
template
void
DoFTools::map_dof_to_boundary_indices<DoFHandler<deal_II_dimension> >
(const DoFHandler<deal_II_dimension> &,
const std::set<types::boundary_id> &,
- std::vector<unsigned int> &);
+ std::vector<types::global_dof_index> &);
template
void
DoFTools::map_dof_to_boundary_indices<DoFHandler<deal_II_dimension> >
(const DoFHandler<deal_II_dimension> &,
- std::vector<unsigned int> &);
+ std::vector<types::global_dof_index> &);
DoFTools::map_dof_to_boundary_indices<hp::DoFHandler<deal_II_dimension> >
(const hp::DoFHandler<deal_II_dimension> &,
const std::set<types::boundary_id> &,
- std::vector<unsigned int> &);
+ std::vector<types::global_dof_index> &);
template
void
DoFTools::map_dof_to_boundary_indices<hp::DoFHandler<deal_II_dimension> >
(const hp::DoFHandler<deal_II_dimension> &,
- std::vector<unsigned int> &);
+ std::vector<types::global_dof_index> &);
DoFTools::map_dofs_to_support_points<deal_II_dimension>
(const Mapping<deal_II_dimension,deal_II_dimension>&,
const DoFHandler<deal_II_dimension>&,
- std::map<unsigned int, Point<deal_II_dimension> >&);
+ std::map<types::global_dof_index, Point<deal_II_dimension> >&);
template
DoFTools::map_dofs_to_support_points<deal_II_dimension>
(const hp::MappingCollection<deal_II_dimension,deal_II_dimension>&,
const hp::DoFHandler<deal_II_dimension>&,
- std::map<unsigned int, Point<deal_II_dimension> >&);
+ std::map<types::global_dof_index, Point<deal_II_dimension> >&);
#if deal_II_dimension < 3
DoFTools::map_dofs_to_support_points<deal_II_dimension,deal_II_dimension+1>
(const Mapping<deal_II_dimension,deal_II_dimension+1>&,
const DoFHandler<deal_II_dimension, deal_II_dimension+1>&,
- std::map<unsigned int, Point<deal_II_dimension+1> >&);
+ std::map<types::global_dof_index, Point<deal_II_dimension+1> >&);
template
void
DoFTools::map_dofs_to_support_points<deal_II_dimension,deal_II_dimension+1>
(const hp::MappingCollection<deal_II_dimension,deal_II_dimension+1>&,
const hp::DoFHandler<deal_II_dimension, deal_II_dimension+1>&,
- std::map<unsigned int, Point<deal_II_dimension+1> >&);
+ std::map<types::global_dof_index, Point<deal_II_dimension+1> >&);
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<unsigned int>&,
- const std::vector<unsigned int> &);
+ std::vector<types::global_dof_index>&,
+ const std::vector<types::global_dof_index> &);
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<unsigned int>&,
- const std::vector<unsigned int> &);
+ std::vector<types::global_dof_index>&,
+ const std::vector<types::global_dof_index> &);
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<unsigned int>&,
- const std::vector<unsigned int> &);
+ std::vector<types::global_dof_index>&,
+ const std::vector<types::global_dof_index> &);
#endif
void
DoFTools::count_dofs_per_block<DoFHandler<1,3> > (
const DoFHandler<1,3>&,
- std::vector<unsigned int>&,
- const std::vector<unsigned int> &);
+ std::vector<types::global_dof_index>&,
+ const std::vector<types::global_dof_index> &);
template
void
DoFTools::count_dofs_per_block<hp::DoFHandler<1,3> > (
const hp::DoFHandler<1,3>&,
- std::vector<unsigned int>&,
- const std::vector<unsigned int> &);
+ std::vector<types::global_dof_index>&,
+ const std::vector<types::global_dof_index> &);
template
void
DoFTools::count_dofs_per_block<MGDoFHandler<1,3> > (
const MGDoFHandler<1,3>&,
- std::vector<unsigned int>&,
- const std::vector<unsigned int> &);
+ std::vector<types::global_dof_index>&,
+ const std::vector<types::global_dof_index> &);
#endif
DoFTools::map_dof_to_boundary_indices<DoFHandler<deal_II_dimension,deal_II_dimension+1> >
(const DoFHandler<deal_II_dimension,deal_II_dimension+1> &,
const std::set<types::boundary_id> &,
- std::vector<unsigned int> &);
+ std::vector<types::global_dof_index> &);
template
void
DoFTools::map_dof_to_boundary_indices<DoFHandler<deal_II_dimension,deal_II_dimension+1> >
(const DoFHandler<deal_II_dimension,deal_II_dimension+1> &,
- std::vector<unsigned int> &);
+ std::vector<types::global_dof_index> &);
template
DoFTools::map_dof_to_boundary_indices<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> >
(const hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> &,
const std::set<types::boundary_id> &,
- std::vector<unsigned int> &);
+ std::vector<types::global_dof_index> &);
template
void
DoFTools::map_dof_to_boundary_indices<hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> >
(const hp::DoFHandler<deal_II_dimension,deal_II_dimension+1> &,
- std::vector<unsigned int> &);
+ std::vector<types::global_dof_index> &);
#endif
DoFTools::map_dof_to_boundary_indices<DoFHandler<1,3> >
(const DoFHandler<1,3> &,
const std::set<types::boundary_id> &,
- std::vector<unsigned int> &);
+ std::vector<types::global_dof_index> &);
template
void
DoFTools::map_dof_to_boundary_indices<DoFHandler<1,3> >
(const DoFHandler<1,3> &,
- std::vector<unsigned int> &);
+ std::vector<types::global_dof_index> &);
template
// DoFTools::map_dof_to_boundary_indices<hp::DoFHandler<1,3> >
// (const hp::DoFHandler<1,3> &,
// const std::set<unsigned char> &,
-// std::vector<unsigned int> &);
+// std::vector<types::global_dof_index> &);
// template
// void
// DoFTools::map_dof_to_boundary_indices<hp::DoFHandler<1,3> >
// (const hp::DoFHandler<1,3> &,
-// std::vector<unsigned int> &);
+// std::vector<types::global_dof_index> &);
#endif
const Point<3> &p,
const double inner_radius,
const double outer_radius,
- const unsigned int n,
+ const size_type n,
const bool colorize)
{
Assert ((inner_radius > 0) && (inner_radius < outer_radius),
const Point<3> ¢er,
const double inner_radius,
const double outer_radius,
- const unsigned int n,
+ const size_type n,
const bool colorize)
{
Assert ((inner_radius > 0) && (inner_radius < outer_radius),
const Point<3> ¢er,
const double inner_radius,
const double outer_radius,
- const unsigned int n,
+ const size_type n,
const bool colorize)
{
Assert ((inner_radius > 0) && (inner_radius < outer_radius),
// throw out duplicated vertices from the two meshes
// and create the triangulation
SubCellData subcell_data;
- std::vector<size_type> considered_vertices;
+ std::vector<unsigned int> considered_vertices;
GridTools::delete_duplicated_vertices (vertices, cells, subcell_data, considered_vertices);
result.clear ();
result.create_triangulation (vertices, cells, subcell_data);
template void
GridGenerator::subdivided_parallelepiped<deal_II_dimension> (
Triangulation<deal_II_dimension>&,
- const unsigned int,
+ const size_type,
const Point<deal_II_dimension> (&) [deal_II_dimension],
const bool);
template void
GridGenerator::subdivided_parallelepiped<deal_II_dimension> (
Triangulation<deal_II_dimension>&,
- const unsigned int [deal_II_dimension],
+ const size_type [deal_II_dimension],
const Point<deal_II_dimension> (&) [deal_II_dimension],
const bool);
template void
GridGenerator::
laplace_transformation<deal_II_dimension> (Triangulation<deal_II_dimension> &,
- const std::map<unsigned int,Point<deal_II_dimension> > &);
+ const std::map<types::global_dof_index,Point<deal_II_dimension> > &);
#endif
template <int dim>
void
- laplace_transform (const std::map<unsigned int,Point<dim> > &new_points,
+ laplace_transform (const std::map<types::global_dof_index,Point<dim> > &new_points,
Triangulation<dim> &triangulation)
{
//TODO: Move implementation of this function into the current
#if deal_II_dimension == deal_II_space_dimension
template
void
- laplace_transform (const std::map<unsigned int,Point<deal_II_dimension> > &new_points,
+ laplace_transform (const std::map<types::global_dof_index,Point<deal_II_dimension> > &new_points,
Triangulation<deal_II_dimension> &triangulation);
template
for (unsigned int level=0; level<dof_handler.tria->n_levels(); ++level)
{
dof_handler.levels[level]->dof_object.dof_offsets
- = std::vector<unsigned int> (dof_handler.tria->n_raw_lines(level),
- DoFHandler<dim,spacedim>::invalid_dof_index);
+ = std::vector<types::global_dof_index> (
+ dof_handler.tria->n_raw_lines(level),
+ DoFHandler<dim,spacedim>::invalid_dof_index);
types::global_dof_index next_free_dof = 0;
for (typename DoFHandler<dim,spacedim>::active_cell_iterator
for (unsigned int level=0; level<dof_handler.tria->n_levels(); ++level)
{
dof_handler.levels[level]->dof_object.dof_offsets
- = std::vector<unsigned int> (dof_handler.tria->n_raw_quads(level),
- DoFHandler<dim,spacedim>::invalid_dof_index);
+ = std::vector<types::global_dof_index> (
+ dof_handler.tria->n_raw_quads(level),
+ DoFHandler<dim,spacedim>::invalid_dof_index);
types::global_dof_index next_free_dof = 0;
for (typename DoFHandler<dim,spacedim>::active_cell_iterator
// active ones will have a
// non-invalid value later on
dof_handler.faces->lines.dof_offsets
- = std::vector<unsigned int> (dof_handler.tria->n_raw_lines(),
+ = std::vector<types::global_dof_index> (dof_handler.tria->n_raw_lines(),
DoFHandler<dim,spacedim>::invalid_dof_index);
dof_handler.faces->lines.dofs
= std::vector<types::global_dof_index> (n_line_slots,
for (unsigned int level=0; level<dof_handler.tria->n_levels(); ++level)
{
dof_handler.levels[level]->dof_object.dof_offsets
- = std::vector<unsigned int> (dof_handler.tria->n_raw_hexs(level),
+ = std::vector<types::global_dof_index> (dof_handler.tria->n_raw_hexs(level),
DoFHandler<dim,spacedim>::invalid_dof_index);
types::global_dof_index next_free_dof = 0;
if (true)
{
dof_handler.faces->quads.dof_offsets
- = std::vector<unsigned int> (dof_handler.tria->n_raw_quads(),
+ = std::vector<types::global_dof_index> (dof_handler.tria->n_raw_quads(),
DoFHandler<dim,spacedim>::invalid_dof_index);
dof_handler.faces->quads.dofs
= std::vector<types::global_dof_index> (n_quad_slots,
unsigned int
max_couplings_between_dofs (const DoFHandler<1,spacedim> &dof_handler)
{
- return std::min(3*dof_handler.finite_elements->max_dofs_per_vertex() +
- 2*dof_handler.finite_elements->max_dofs_per_line(), dof_handler.n_dofs());
+ return std::min(static_cast<types::global_dof_index> (3*
+ dof_handler.finite_elements->max_dofs_per_vertex() +
+ 2*dof_handler.finite_elements->max_dofs_per_line()),
+ dof_handler.n_dofs());
}
// nodes)
// count lines -> 28 (don't forget to count
// mother and children separately!)
- unsigned int max_couplings;
+ types::global_dof_index max_couplings;
switch (dof_handler.tria->max_adjacent_cells())
{
case 4:
// can anyone give better estimate here?
const unsigned int max_adjacent_cells = dof_handler.tria->max_adjacent_cells();
- unsigned int max_couplings;
+ types::global_dof_index max_couplings;
if (max_adjacent_cells <= 8)
max_couplings=7*7*7*dof_handler.finite_elements->max_dofs_per_vertex() +
7*6*7*3*dof_handler.finite_elements->max_dofs_per_line() +
Assert (number_cache.n_global_dofs < std::numeric_limits<unsigned int>::max (),
ExcMessage ("Global number of degrees of freedom is too large."));
number_cache.n_locally_owned_dofs_per_processor
- = std::vector<unsigned int> (1,
- (unsigned int) number_cache.n_global_dofs);
+ = std::vector<types::global_dof_index> (1,
+ (types::global_dof_index) number_cache.n_global_dofs);
number_cache.locally_owned_dofs_per_processor
= std::vector<IndexSet> (1,
template class DoFHandler<deal_II_dimension, deal_II_dimension+1>;
template
- unsigned int
+ types::global_dof_index
DoFHandler<deal_II_dimension, deal_II_dimension+1>::get_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
template
void
- DoFHandler<deal_II_dimension, deal_II_dimension+1>::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
+ DoFHandler<deal_II_dimension, deal_II_dimension+1>::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const;
#if deal_II_dimension >= 2
template
- unsigned int
+ types::global_dof_index
DoFHandler<deal_II_dimension, deal_II_dimension+1>::get_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
template
void
- DoFHandler<deal_II_dimension, deal_II_dimension+1>::set_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
+ DoFHandler<deal_II_dimension, deal_II_dimension+1>::set_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const;
#endif
#endif
template class DoFHandler<1, 3>;
template
-unsigned int
+types::global_dof_index
DoFHandler<1,3>::get_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
template
void
-DoFHandler<1,3>::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, unsigned int) const;
+DoFHandler<1,3>::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const;
#endif
template
-unsigned int
+types::global_dof_index
DoFHandler<deal_II_dimension>::get_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
#if deal_II_dimension >= 2
template
-unsigned int
+types::global_dof_index
DoFHandler<deal_II_dimension>::get_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
#if deal_II_dimension >= 3
template
-unsigned int
+types::global_dof_index
DoFHandler<deal_II_dimension>::get_dof_index<3> (const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
#endif
#endif
template
void
-DoFHandler<deal_II_dimension>::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
+DoFHandler<deal_II_dimension>::set_dof_index<1> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const;
#if deal_II_dimension >= 2
template
void
-DoFHandler<deal_II_dimension>::set_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
+DoFHandler<deal_II_dimension>::set_dof_index<2> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const;
#if deal_II_dimension >= 3
template
void
-DoFHandler<deal_II_dimension>::set_dof_index<3> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const unsigned int) const;
+DoFHandler<deal_II_dimension>::set_dof_index<3> (const unsigned int, const unsigned int, const unsigned int, const unsigned int, const types::global_dof_index) const;
#endif
#endif
\}
template
void FullMatrix<S1>::fill<S2> (
- const FullMatrix<S2>&, unsigned, unsigned, unsigned, unsigned);
+ const FullMatrix<S2>&, types::global_dof_index, types::global_dof_index, types::global_dof_index, types::global_dof_index);
template
void FullMatrix<S1>::add<S2> (const S1, const FullMatrix<S2>&);
template
const S1, const FullMatrix<S2>&);
template
void FullMatrix<S1>::add<S2> (
- const FullMatrix<S2>&, S1, unsigned, unsigned,unsigned, unsigned);
+ const FullMatrix<S2>&, S1, types::global_dof_index, types::global_dof_index, types::global_dof_index, types::global_dof_index);
template
void FullMatrix<S1>::Tadd<S2> (const S1, const FullMatrix<S2>&);
template
void FullMatrix<S1>::Tadd<S2> (
- const FullMatrix<S2>&, S1, unsigned, unsigned, unsigned, unsigned);
+ const FullMatrix<S2>&, S1, types::global_dof_index, types::global_dof_index, types::global_dof_index, types::global_dof_index);
template
void FullMatrix<S1>::equ<S2> (const S1, const FullMatrix<S2>&);
template
template
void FullMatrix<S1>::fill_permutation<S2> (
const FullMatrix<S2>&,
- const std::vector<unsigned int>&,
- const std::vector<unsigned int>&);
+ const std::vector<size_type>&,
+ const std::vector<size_type>&);
template
void FullMatrix<S1>::vmult<S2>(
Vector<S2>&, const Vector<S2>&, bool) const;
{
template
void FullMatrix<S1>::fill<S2> (
- const FullMatrix<S2>&, unsigned, unsigned, unsigned, unsigned);
+ const FullMatrix<S2>&, types::global_dof_index, types::global_dof_index, types::global_dof_index, types::global_dof_index);
template
void FullMatrix<S1>::add<S2> (const S1, const FullMatrix<S2>&);
template
const S1, const FullMatrix<S2>&);
template
void FullMatrix<S1>::add<S2> (
- const FullMatrix<S2>&, S1, unsigned, unsigned,unsigned, unsigned);
+ const FullMatrix<S2>&, S1, types::global_dof_index, types::global_dof_index, types::global_dof_index, types::global_dof_index);
template
void FullMatrix<S1>::Tadd<S2> (const S1, const FullMatrix<S2>&);
template
void FullMatrix<S1>::Tadd<S2> (
- const FullMatrix<S2>&, S1, unsigned, unsigned, unsigned, unsigned);
+ const FullMatrix<S2>&, S1, types::global_dof_index, types::global_dof_index,
+ types::global_dof_index, types::global_dof_index);
template
void FullMatrix<S1>::equ<S2> (const S1, const FullMatrix<S2>&);
template
template
void FullMatrix<S1>::fill_permutation<S2> (
const FullMatrix<S2>&,
- const std::vector<unsigned int>&,
- const std::vector<unsigned int>&);
+ const std::vector<size_type>&,
+ const std::vector<size_type>&);
template
void FullMatrix<S1>::vmult<S2>(
Vector<S2>&, const Vector<S2>&, bool) const;
extern "C"
void ma47id_ (double *,
- size_type *)
+ unsigned int *)
{
AssertThrow (false,
ExcMessage("You can only use the HSL functions after putting "
size_type *,
const size_type *,
size_type *,
- const size_type *,
+ const unsigned int *,
double *,
int *)
{
const size_type *,
const size_type *,
const double *,
- const size_type *,
+ const unsigned int *,
size_type *,
double *,
int *)
double *,
double *,
size_type *,
- const size_type *)
+ const unsigned int *)
{
AssertThrow (false,
ExcMessage("You can only use the HSL functions after putting "
void
-SparseDirectMA47::call_ma47id (double *CNTL, // length 2
- size_type *ICNTL) // length 7
+SparseDirectMA47::call_ma47id (double *CNTL, // length 2
+ unsigned int *ICNTL) // length 7
{
HSL::MA47::ma47id_ (CNTL, ICNTL);
}
template void SparseMatrix<S1>::add<S2> (const S1,
const SparseMatrix<S2> &);
- template void SparseMatrix<S1>::add<S2> (const unsigned int,
- const unsigned int,
- const unsigned int *,
+ template void SparseMatrix<S1>::add<S2> (const size_type,
+ const size_type,
+ const size_type *,
const S2 *,
const bool,
const bool);
- template void SparseMatrix<S1>::set<S2> (const unsigned int,
- const unsigned int,
- const unsigned int *,
+ template void SparseMatrix<S1>::set<S2> (const size_type,
+ const size_type,
+ const size_type *,
const S2 *,
const bool);
}
const S1) const;
template void SparseMatrix<S1>::
PSOR<S2> (Vector<S2> &,
- const std::vector<unsigned int>&,
- const std::vector<unsigned int>&,
+ const std::vector<size_type>&,
+ const std::vector<size_type>&,
const S1) const;
template void SparseMatrix<S1>::
TPSOR<S2> (Vector<S2> &,
- const std::vector<unsigned int>&,
- const std::vector<unsigned int>&,
+ const std::vector<size_type>&,
+ const std::vector<size_type>&,
const S1) const;
template void SparseMatrix<S1>::
Jacobi_step<S2> (Vector<S2> &,
// const S1) const;
// template void SparseMatrix<S1>::
// PSOR<S2> (Vector<S2> &,
-// const std::vector<unsigned int>&,
-// const std::vector<unsigned int>&,
+// const std::vector<size_type>&,
+// const std::vector<size_type>&,
// const S1) const;
// template void SparseMatrix<S1>::
// TPSOR<S2> (Vector<S2> &,
-// const std::vector<unsigned int>&,
-// const std::vector<unsigned int>&,
+// const std::vector<size_type>&,
+// const std::vector<size_type>&,
// const S1) const;
// template void SparseMatrix<S1>::
// SOR_step<S2> (Vector<S2> &,
std::size_t vec_len = 0;
for (size_type i=0; i<m; ++i)
vec_len += std::min((store_diagonal_first_in_row ?
- std::max(row_lengths[i], 1U) :
+ std::max(row_lengths[i], static_cast<size_type> (1U)) :
row_lengths[i]),
n);
for (size_type i=1; i<=rows; ++i)
rowstart[i] = rowstart[i-1] +
(store_diagonal_first_in_row ?
- std::max(std::min(row_lengths[i-1],n),1U) :
+ std::max(std::min(row_lengths[i-1],n),static_cast<size_type> (1U)) :
std::min(row_lengths[i-1],n));
Assert ((rowstart[rows]==vec_len)
||
ExcDimensionMismatch (sparsity.n_cols(), n_dofs));
const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell;
- std::vector<unsigned int> dofs_on_this_cell(dofs_per_cell);
- std::vector<unsigned int> dofs_on_other_cell(dofs_per_cell);
+ std::vector<types::global_dof_index> dofs_on_this_cell(dofs_per_cell);
+ std::vector<types::global_dof_index> dofs_on_other_cell(dofs_per_cell);
typename DoFHandler<dim,spacedim>::cell_iterator cell = dof.begin(level),
endc = dof.end(level);
for (; cell!=endc; ++cell)
#endif
template void count_dofs_per_component (
- const DoFHandler<deal_II_dimension>&, std::vector<std::vector<unsigned int> >&,
- bool, std::vector<unsigned int>);
+ const DoFHandler<deal_II_dimension>&, std::vector<std::vector<types::global_dof_index> >&,
+ bool, std::vector<types::global_dof_index>);
template void count_dofs_per_component (
- const DoFHandler<deal_II_dimension>&, std::vector<std::vector<unsigned int> >&,
- std::vector<unsigned int>);
+ const DoFHandler<deal_II_dimension>&, std::vector<std::vector<types::global_dof_index> >&,
+ std::vector<types::global_dof_index>);
template void count_dofs_per_block (
- const DoFHandler<deal_II_dimension>&, std::vector<std::vector<unsigned int> >&,
- std::vector<unsigned int>);
+ const DoFHandler<deal_II_dimension>&, std::vector<std::vector<types::global_dof_index> >&,
+ std::vector<types::global_dof_index>);
template void count_dofs_per_block (
- const MGDoFHandler<deal_II_dimension>&, std::vector<std::vector<unsigned int> >&,
- std::vector<unsigned int>);
+ const MGDoFHandler<deal_II_dimension>&, std::vector<std::vector<types::global_dof_index> >&,
+ std::vector<types::global_dof_index>);
#if deal_II_dimension > 1
template void make_boundary_list(
const DoFHandler<deal_II_dimension>&,
const FunctionMap<deal_II_dimension>::type&,
- std::vector<std::set<unsigned int> >&,
+ std::vector<std::set<types::global_dof_index> >&,
const ComponentMask &);
#endif
template
void
extract_non_interface_dofs (const DoFHandler<deal_II_dimension> & mg_dof_handler,
- std::vector<std::set<unsigned int> > &non_interface_dofs);
+ std::vector<std::set<types::global_dof_index> > &non_interface_dofs);
#if deal_II_dimension < 3
template void count_dofs_per_block (
const DoFHandler<deal_II_dimension,deal_II_dimension+1>&,
- std::vector<std::vector<unsigned int> >&, std::vector<unsigned int>);
+ std::vector<std::vector<types::global_dof_index> >&, std::vector<types::global_dof_index>);
#endif
#if deal_II_dimension == 3
template void count_dofs_per_block (
const DoFHandler<1,3>&,
- std::vector<std::vector<unsigned int> >&, std::vector<unsigned int>);
+ std::vector<std::vector<types::global_dof_index> >&, std::vector<types::global_dof_index>);
#endif
\}
}
unsigned int, unsigned int,
const std::vector<unsigned int>&,
const std::vector<unsigned int>&,
- const std::vector<std::set<unsigned int> >&);
+ const std::vector<std::set<types::global_dof_index> >&);
template
void MGTransferSelect<double>::build_matrices<deal_II_dimension>
unsigned int, unsigned int,
const std::vector<unsigned int>&,
const std::vector<unsigned int>&,
- const std::vector<std::set<unsigned int> >&);
+ const std::vector<std::set<types::global_dof_index> >&);
template void
MGTransferSelect<float>::copy_to_mg (