inline
-types::global_dof_index
-IndexSet::index_within_set (const unsigned int n) const
+unsigned int
+IndexSet::index_within_set (const types::global_dof_index n) const
{
// to make this call thread-safe, compress()
// must not be called through this function
inline
std::size_t memory_consumption (const unsigned int);
+ /**
+ * Determine the amount of memory
+ * in bytes consumed by a <tt>unsigned long long int</tt>
+ * variable.
+ */
+ inline
+ std::size_t memory_consumption (const unsigned long long int);
+
/**
* Determine the amount of memory
* in bytes consumed by a <tt>float</tt>
{
return sizeof(int);
}
-
+
inline
return sizeof(unsigned int);
}
+
+
+ inline
+ std::size_t memory_consumption (const unsigned long long int)
+ {
+ return sizeof(unsigned long long int);
+ }
+
inline
static
void set_mg_dof_indices (const dealii::DoFAccessor<1,DH,lda> &,
const int,
- const std::vector<unsigned int> &,
+ const std::vector<types::global_dof_index> &,
const unsigned int)
{
AssertThrow (false, ExcNotImplemented ()); //TODO[TH]: implement
static
void set_mg_dof_indices (dealii::DoFAccessor<2, DH,lda> &accessor,
const int level,
- const std::vector<unsigned int> &dof_indices,
+ const 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>::const_iterator next = dof_indices.begin ();
+ std::vector<types::global_dof_index>::const_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)
static
void set_mg_dof_indices (const dealii::DoFAccessor<3, DH,lda> &,
const int,
- const std::vector<unsigned int> &,
+ const std::vector<types::global_dof_index> &,
const unsigned int)
{
AssertThrow (false, ExcNotImplemented ()); //TODO[TH]: implement
template <class DH, bool lda>
inline
void
-DoFCellAccessor<DH,lda>::get_dof_indices (std::vector<unsigned int> &dof_indices) const
+DoFCellAccessor<DH,lda>::get_dof_indices (std::vector<types::global_dof_index> &dof_indices) const
{
Assert (this->is_artificial() == false,
ExcMessage ("Can't ask for DoF indices on artificial cells."));
* certain value, but rather take
* its symbolic name.
*/
- static const unsigned int invalid_dof_index = numbers::invalid_unsigned_int;
+ static const types::global_dof_index invalid_dof_index = numbers::invalid_dof_index;
/**
* The default index of the
template<int dim, int spacedim>
inline
-unsigned int DoFHandler<dim, spacedim>::n_dofs (const unsigned int level) const
+types::global_dof_index DoFHandler<dim, spacedim>::n_dofs (const unsigned int level) const
{
Assert(has_level_dofs(), ExcMessage("n_dofs(level) can only be called after distribute_mg_dofs()"));
Assert (level < mg_number_cache.size (), ExcInvalidLevel (level));
template<int dim, int spacedim>
inline
-unsigned int DoFHandler<dim, spacedim>::MGVertexDoFs::get_index (
+types::global_dof_index DoFHandler<dim, spacedim>::MGVertexDoFs::get_index (
const unsigned int level,
const unsigned int dof_number) const
{
void DoFHandler<dim, spacedim>::MGVertexDoFs::set_index (
const unsigned int level,
const unsigned int dof_number,
- const unsigned int index)
+ const types::global_dof_index index)
{
Assert ((level >= coarsest_level) && (level <= finest_level), ExcInvalidLevel (level));
indices[indices_offset[level - coarsest_level] + dof_number] = index;
inline
unsigned int
DoFObjects<dim>::n_active_fe_indices (const dealii::DoFHandler<dh_dim,spacedim> &,
- const unsigned) const
+ const types::global_dof_index) const
{
return 1;
}
/**
* Number of degrees of freedom on a vertex.
*/
- const unsigned int dofs_per_vertex;
+ const types::global_dof_index dofs_per_vertex;
/**
* Number of degrees of freedom in a line; not including the degrees of
* freedom on the vertices of the line.
*/
- const unsigned int dofs_per_line;
+ const types::global_dof_index dofs_per_line;
/**
* Number of degrees of freedom in a quadrilateral; not including the
void
FEValuesBase<dim,spacedim>::get_function_grads (
const InputVector &fe_function,
- const VectorSlice<const std::vector<unsigned int> > &indices,
+ const VectorSlice<const std::vector<types::global_dof_index> > &indices,
std::vector<Tensor<1,spacedim> > &values) const
{
get_function_gradients(fe_function, indices, values);
void
FEValuesBase<dim,spacedim>::get_function_grads (
const InputVector &fe_function,
- const VectorSlice<const std::vector<unsigned int> > &indices,
+ const VectorSlice<const std::vector<types::global_dof_index> > &indices,
std::vector<std::vector<Tensor<1,spacedim> > > &values,
bool q_points_fastest) const
{
* cells are also not necessarily
* included.
*/
- unsigned int n_locally_owned_dofs() const;
+ types::global_dof_index n_locally_owned_dofs() const;
/**
* Return an IndexSet describing
* then the vector has a single
* element equal to n_dofs().
*/
- const std::vector<unsigned int> &
+ const std::vector<types::global_dof_index> &
n_locally_owned_dofs_per_processor () const;
/**
* on this object.
*/
template <int dimm, int spacedim>
- unsigned int
+ types::global_dof_index
nth_active_fe_index (const dealii::hp::DoFHandler<dimm,spacedim> &dof_handler,
const unsigned int obj_level,
const unsigned int obj_index,
// find a set for this
// particular fe_index
const types::global_dof_index starting_offset = dof_offsets[obj_index];
- const unsigned int *pointer = &dofs[starting_offset];
+ const types::global_dof_index *pointer = &dofs[starting_offset];
while (true)
{
Assert (*pointer != numbers::invalid_unsigned_int,
// find a set for this
// particular fe_index
const types::global_dof_index starting_offset = dof_offsets[obj_index];
- unsigned int *pointer = &dofs[starting_offset];
+ types::global_dof_index *pointer = &dofs[starting_offset];
while (true)
{
Assert (*pointer != numbers::invalid_unsigned_int,
* the cache. This array is always
* kept sorted.
*/
- mutable std::vector<unsigned int> entries;
+ mutable std::vector<size_type> entries;
/**
* Cache of entries that have not yet
* Call the <tt>ma47ad</tt> function
* with the given args.
*/
- void call_ma47ad (const size_type *n_rows,
- const size_type *n_nonzero_elements,
- size_type *row_numbers,
- size_type *column_numbers,
- size_type *IW,
- const size_type *LIW,
- size_type *KEEP,
- const size_type *ICNTL,
- int *INFO);
+ void call_ma47ad (const size_type *n_rows,
+ const size_type *n_nonzero_elements,
+ size_type *row_numbers,
+ size_type *column_numbers,
+ size_type *IW,
+ const size_type *LIW,
+ size_type *KEEP,
+ const unsigned int *ICNTL,
+ int *INFO);
/**
* Call the <tt>ma47bd</tt> function
template <class Archive>
inline
void
-SparsityPattern::save (Archive &ar, const size_type) const
+SparsityPattern::save (Archive &ar, const unsigned int) const
{
// forward to serialization function in the base class.
ar &static_cast<const Subscriptor &>(*this);
template <class Archive>
inline
void
-SparsityPattern::load (Archive &ar, const size_type)
+SparsityPattern::load (Archive &ar, const unsigned int)
{
// forward to serialization function in the base class.
ar &static_cast<Subscriptor &>(*this);
* assigned the correct index after all the ghost indices have been
* collected by the call to @p assign_ghosts.
*/
- void read_dof_indices (const std::vector<unsigned int> &local_indices,
+ void read_dof_indices (const std::vector<types::global_dof_index> &local_indices,
const std::vector<unsigned int> &lexicographic_inv,
const ConstraintMatrix &constraints,
const unsigned int cell_number,
inline
- const unsigned int *
+ const types::global_dof_index *
DoFInfo::begin_indices_plain (const unsigned int row) const
{
// if we have no constraints, should take the data from dof_indices
inline
- const unsigned int *
+ const types::global_dof_index *
DoFInfo::end_indices_plain (const unsigned int row) const
{
return begin_indices_plain(row) +
namespace internal
{
// rudimentary version of a vector that keeps entries always ordered
- class ordered_vector : public std::vector<unsigned int>
+ class ordered_vector : public std::vector<types::global_dof_index>
{
public:
ordered_vector ()
reserve (2000);
}
- void reserve (const unsigned int size)
+ void reserve (const types::global_dof_index size)
{
if (size > 0)
- this->std::vector<unsigned int>::reserve (size);
+ this->std::vector<types::global_dof_index>::reserve (size);
}
// insert a given entry. dat is a pointer within this vector (the user
// needs to make sure that it really stays there)
- void insert (const unsigned int entry,
- std::vector<unsigned int>::iterator &dat)
+ void insert (const types::global_dof_index entry,
+ std::vector<types::global_dof_index>::iterator &dat)
{
- AssertIndexRange (static_cast<unsigned int>(dat - begin()), size()+1);
- AssertIndexRange (static_cast<unsigned int>(end() - dat), size()+1);
+ AssertIndexRange (static_cast<types::global_dof_index>(dat - begin()), size()+1);
+ AssertIndexRange (static_cast<types::global_dof_index>(end() - dat), size()+1);
AssertIndexRange (size(), capacity());
while (dat != end() && *dat < entry)
++dat;
}
else if (*dat > entry)
{
- dat = this->std::vector<unsigned int>::insert (dat, entry);
+ dat = this->std::vector<types::global_dof_index>::insert (dat, entry);
++dat;
}
else
CompressedSimpleSparsityPattern &connectivity) const
{
AssertDimension (row_starts.size()-1, size_info.n_active_cells);
- const unsigned int n_rows = (vector_partitioner->local_range().second-
+ const types::global_dof_index n_rows =
+ (vector_partitioner->local_range().second-
vector_partitioner->local_range().first)
+ vector_partitioner->ghost_indices().n_elements();
- const unsigned int n_blocks = (do_blocking == true) ?
+ const types::global_dof_index n_blocks = (do_blocking == true) ?
task_info.n_blocks : size_info.n_active_cells;
// first determine row lengths
- std::vector<unsigned int> row_lengths(n_rows);
+ std::vector<types::global_dof_index> row_lengths(n_rows);
unsigned int cell_start = 0, mcell_start = 0;
std::vector<types::global_dof_index> scratch;
- for (unsigned int block = 0; block < n_blocks; ++block)
+ for (types::global_dof_index block = 0; block < n_blocks; ++block)
{
// if we have the blocking variant (used in the coloring scheme), we
// want to build a graph with the blocks with interaction with
}
// disregard dofs that only sit on one cell
- for (unsigned int row=0; row<n_rows; ++row)
+ for (types::global_dof_index row=0; row<n_rows; ++row)
if (row_lengths[row] == 1)
row_lengths[row] = 0;
* vector, not in global numbers. In addition, it only returns the indices
* for degrees of freedom that are owned locally, not for ghosts.
*/
- const std::vector<unsigned int> &
+ const std::vector<types::global_dof_index> &
get_constrained_dofs (const unsigned int fe_component = 0) const;
/**
* Calls renumber_dofs function in dof info which renumbers the degrees
* of freedom according to the ordering for parallelization.
*/
- void renumber_dofs (std::vector<unsigned int> &renumbering,
+ void renumber_dofs (std::vector<types::global_dof_index> &renumbering,
const unsigned int vector_component = 0);
//@}
template <int dim, typename Number>
inline
-const std::vector<unsigned int> &
+const std::vector<types::global_dof_index> &
MatrixFree<dim,Number>::get_constrained_dofs (const unsigned int comp) const
{
AssertIndexRange (comp, n_components());
template <int dim, typename Number>
inline
void
-MatrixFree<dim,Number>::renumber_dofs (std::vector<unsigned int> &renumbering,
+MatrixFree<dim,Number>::renumber_dofs (std::vector<types::global_dof_index> &renumbering,
const unsigned int vector_component)
{
AssertIndexRange(vector_component, dof_info.size());
AssertDimension (n_fe, locally_owned_set.size());
AssertDimension (n_fe, constraint.size());
- std::vector<unsigned int> local_dof_indices;
+ std::vector<types::global_dof_index> local_dof_indices;
std::vector<std::vector<unsigned int> > ghost_dofs(n_fe);
std::vector<std::vector<std::vector<unsigned int> > > lexicographic_inv(n_fe);
}
// set constraint pool from the std::map and reorder the indices
- typename std::map<std::vector<double>, unsigned int,
+ typename std::map<std::vector<double>, types::global_dof_index,
internal::MatrixFreeFunctions::FPArrayComparator<double> >::iterator
it = constraint_values.constraints.begin(),
end = constraint_values.constraints.end();
template <class DH>
DoFInfo<dim,spacedim,number>::DoFInfo(const DH &dof_handler)
{
- std::vector<unsigned int> aux(1);
+ std::vector<types::global_dof_index> aux(1);
aux[0] = dof_handler.get_fe().dofs_per_cell;
aux_local_indices.reinit(aux);
}
std::vector<std::vector<std::vector<Tensor<1,dim> > > > &gradients,
std::vector<std::vector<std::vector<Tensor<2,dim> > > > &hessians,
const FEValuesBase<dim,spacedim> &fe,
- const std::vector<unsigned int> &index,
+ const std::vector<types::global_dof_index> &index,
const unsigned int component,
const unsigned int n_comp,
const unsigned int start,
std::vector<std::vector<std::vector<Tensor<2,dim> > > > &hessians,
const FEValuesBase<dim,spacedim> &fe,
const unsigned int level,
- const std::vector<unsigned int> &index,
+ const std::vector<types::global_dof_index> &index,
const unsigned int component,
const unsigned int n_comp,
const unsigned int start,
std::vector<std::vector<std::vector<Tensor<1,dim> > > > &gradients,
std::vector<std::vector<std::vector<Tensor<2,dim> > > > &hessians,
const FEValuesBase<dim,spacedim> &fe,
- const std::vector<unsigned int> &index,
+ const std::vector<types::global_dof_index> &index,
const unsigned int component,
const unsigned int n_comp,
const unsigned int start,
std::vector<std::vector<std::vector<Tensor<2,dim> > > > &hessians,
const FEValuesBase<dim,spacedim> &fe,
const unsigned int level,
- const std::vector<unsigned int> &index,
+ const std::vector<types::global_dof_index> &index,
const unsigned int component,
const unsigned int n_comp,
const unsigned int start,
std::vector<std::vector<std::vector<Tensor<1,dim> > > > &,
std::vector<std::vector<std::vector<Tensor<2,dim> > > > &,
const FEValuesBase<dim,spacedim> &,
- const std::vector<unsigned int> &,
+ const std::vector<types::global_dof_index> &,
const unsigned int,
const unsigned int,
const unsigned int,
std::vector<std::vector<std::vector<Tensor<2,dim> > > > &,
const FEValuesBase<dim,spacedim> &,
const unsigned int,
- const std::vector<unsigned int> &,
+ const std::vector<types::global_dof_index> &,
const unsigned int,
const unsigned int,
const unsigned int,
std::vector<std::vector<std::vector<Tensor<1,dim> > > > &gradients,
std::vector<std::vector<std::vector<Tensor<2,dim> > > > &hessians,
const FEValuesBase<dim,spacedim> &fe,
- const std::vector<unsigned int> &index,
+ const std::vector<types::global_dof_index> &index,
const unsigned int component,
const unsigned int n_comp,
const unsigned int start,
std::vector<std::vector<std::vector<Tensor<2,dim> > > > &hessians,
const FEValuesBase<dim,spacedim> &fe,
const unsigned int level,
- const std::vector<unsigned int> &index,
+ const std::vector<types::global_dof_index> &index,
const unsigned int component,
const unsigned int n_comp,
const unsigned int start,
struct Pointerstruct
{
Pointerstruct() : indices_ptr(0), dof_values_ptr(0), active_fe_index(0) {};
- Pointerstruct(std::vector<unsigned int> *indices_ptr_in,
+ Pointerstruct(std::vector<types::global_dof_index> *indices_ptr_in,
const unsigned int active_fe_index_in = 0)
:
indices_ptr(indices_ptr_in),
active_fe_index(active_fe_index_in) {};
std::size_t memory_consumption () const;
- std::vector<unsigned int> *indices_ptr;
+ std::vector<types::global_dof_index> *indices_ptr;
std::vector<Vector<typename VECTOR::value_type> > *dof_values_ptr;
unsigned int active_fe_index;
};
std::vector<bool> dofs_processed (dofs_per_face);
std::vector<double> dof_values (dofs_per_face);
- std::vector<unsigned int> face_dof_indices (dofs_per_face);
+ std::vector<types::global_dof_index> face_dof_indices (dofs_per_face);
typename DoFHandler<dim>::active_cell_iterator cell = dof_handler.begin_active ();
switch (dim)
const Function<dim> &,
const std::vector<DerivativeForm<1,dim,dim> > &,
std::vector<double> &,
- std::vector<unsigned int> &)
+ std::vector<types::global_dof_index> &)
{
Assert (false, ExcNotImplemented ());
}
if (!levels_only && dof.has_active_dofs())
{
const FiniteElement<dim, spacedim> &fe = dof.get_fe();
- std::vector<unsigned int> sizes(fe.n_blocks());
+ std::vector<types::global_dof_index> sizes(fe.n_blocks());
DoFTools::count_dofs_per_block(dof, sizes);
bi_global.reinit(sizes);
}
if (!active_only && dof.has_level_dofs())
{
- std::vector<std::vector<unsigned int> > sizes (dof.get_tria ().n_levels ());
+ std::vector<std::vector<types::global_dof_index> > sizes (dof.get_tria ().n_levels ());
for (unsigned int i = 0; i < sizes.size (); ++i)
sizes[i].resize (dof.get_fe ().n_blocks ());
BlockInfo::initialize_local(const DoFHandler<dim, spacedim> &dof)
{
const FiniteElement<dim, spacedim> &fe = dof.get_fe();
- std::vector<unsigned int> sizes(fe.n_blocks());
+ std::vector<types::global_dof_index> sizes(fe.n_blocks());
base_elements.resize(fe.n_blocks());
// 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:
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.selected_fe->dofs_per_vertex +
7*6*7*3*dof_handler.selected_fe->dofs_per_line +
for (unsigned int i = 0; i < n_levels; ++i)
{
dof_handler.mg_levels.push_back (new internal::DoFHandler::DoFLevel<1>);
- dof_handler.mg_levels.back ()->dof_object.dofs = std::vector<unsigned int> (tria.n_raw_lines (i) * dofs_per_line, DoFHandler<1>::invalid_dof_index);
+ dof_handler.mg_levels.back ()->dof_object.dofs = std::vector<types::global_dof_index> (tria.n_raw_lines (i) * dofs_per_line, DoFHandler<1>::invalid_dof_index);
}
const unsigned int &n_vertices = tria.n_vertices ();
for (unsigned int i = 0; i < n_levels; ++i)
{
dof_handler.mg_levels.push_back (new internal::DoFHandler::DoFLevel<2>);
- dof_handler.mg_levels.back ()->dof_object.dofs = std::vector<unsigned int> (tria.n_raw_quads (i) * fe.dofs_per_quad, DoFHandler<2>::invalid_dof_index);
+ dof_handler.mg_levels.back ()->dof_object.dofs = std::vector<types::global_dof_index> (tria.n_raw_quads (i) * fe.dofs_per_quad, DoFHandler<2>::invalid_dof_index);
}
dof_handler.mg_faces = new internal::DoFHandler::DoFFaces<2>;
- dof_handler.mg_faces->lines.dofs = std::vector<unsigned int> (tria.n_raw_lines () * fe.dofs_per_line, DoFHandler<2>::invalid_dof_index);
+ dof_handler.mg_faces->lines.dofs = std::vector<types::global_dof_index> (tria.n_raw_lines () * fe.dofs_per_line, DoFHandler<2>::invalid_dof_index);
const unsigned int &n_vertices = tria.n_vertices ();
for (unsigned int i = 0; i < n_levels; ++i)
{
dof_handler.mg_levels.push_back (new internal::DoFHandler::DoFLevel<3>);
- dof_handler.mg_levels.back ()->dof_object.dofs = std::vector<unsigned int> (tria.n_raw_hexs (i) * fe.dofs_per_hex, DoFHandler<3>::invalid_dof_index);
+ dof_handler.mg_levels.back ()->dof_object.dofs = std::vector<types::global_dof_index> (tria.n_raw_hexs (i) * fe.dofs_per_hex, DoFHandler<3>::invalid_dof_index);
}
dof_handler.mg_faces = new internal::DoFHandler::DoFFaces<3>;
- dof_handler.mg_faces->lines.dofs = std::vector<unsigned int> (tria.n_raw_lines () * fe.dofs_per_line, DoFHandler<3>::invalid_dof_index);
- dof_handler.mg_faces->quads.dofs = std::vector<unsigned int> (tria.n_raw_quads () * fe.dofs_per_quad, DoFHandler<3>::invalid_dof_index);
+ dof_handler.mg_faces->lines.dofs = std::vector<types::global_dof_index> (tria.n_raw_lines () * fe.dofs_per_line, DoFHandler<3>::invalid_dof_index);
+ dof_handler.mg_faces->quads.dofs = std::vector<types::global_dof_index> (tria.n_raw_quads () * fe.dofs_per_quad, DoFHandler<3>::invalid_dof_index);
const unsigned int &n_vertices = tria.n_vertices ();
for (unsigned int d=0; d<this->get_fe().dofs_per_vertex; ++d)
i->set_index (level, d, new_numbers[i->get_index (level, d)]);
- for (std::vector<unsigned int>::iterator i=mg_levels[level]->dof_object.dofs.begin();
+ for (std::vector<types::global_dof_index>::iterator i=mg_levels[level]->dof_object.dofs.begin();
i!=mg_levels[level]->dof_object.dofs.end(); ++i)
{
if (*i != DoFHandler<1>::invalid_dof_index)
const_cast<Triangulation<2> &>(this->get_tria()).load_user_flags (user_flags);
}
- for (std::vector<unsigned int>::iterator i=mg_levels[level]->dof_object.dofs.begin();
+ for (std::vector<types::global_dof_index>::iterator i=mg_levels[level]->dof_object.dofs.begin();
i!=mg_levels[level]->dof_object.dofs.end(); ++i)
{
if (*i != DoFHandler<2>::invalid_dof_index)
}
//HEX DoFs
- for (std::vector<unsigned int>::iterator i=mg_levels[level]->dof_object.dofs.begin();
+ for (std::vector<types::global_dof_index>::iterator i=mg_levels[level]->dof_object.dofs.begin();
i!=mg_levels[level]->dof_object.dofs.end(); ++i)
{
if (*i != DoFHandler<3>::invalid_dof_index)
const unsigned int n_levels = finest_level - coarsest_level + 1;
const unsigned int n_indices = n_levels * dofs_per_vertex;
- indices = new unsigned int[n_indices];
+ indices = new types::global_dof_index[n_indices];
Assert (indices != 0, ExcNoMemory ());
for (unsigned int i = 0; i < n_indices; ++i)
indices[i] = DoFHandler<dim, spacedim>::invalid_dof_index;
- indices_offset = new unsigned int[n_levels];
+ indices_offset = new types::global_dof_index[n_levels];
Assert (indices != 0, ExcNoMemory ());
for (unsigned int i = 0; i < n_levels; ++i)
template class DoFHandler<1,deal_II_dimension>;
template
- unsigned int
+ types::global_dof_index
DoFHandler<1,3>::
get_dof_index<1> (const unsigned int obj_level,
const unsigned int obj_index,
#endif
template
-unsigned int
+types::global_dof_index
DoFHandler<deal_II_dimension,deal_II_dimension>::
get_dof_index<1> (const unsigned int obj_level,
const unsigned int obj_index,
#if deal_II_dimension < 3
template
-unsigned int
+types::global_dof_index
DoFHandler<deal_II_dimension,deal_II_dimension+1>::
get_dof_index<1> (const unsigned int obj_level,
const unsigned int obj_index,
#if deal_II_dimension >= 2
template
-unsigned int
+types::global_dof_index
DoFHandler<deal_II_dimension,deal_II_dimension>::
get_dof_index<2> (const unsigned int obj_level,
const unsigned int obj_index,
#if deal_II_dimension < 3
template
-unsigned int
+types::global_dof_index
DoFHandler<deal_II_dimension,deal_II_dimension+1>::
get_dof_index<2> (const unsigned int obj_level,
const unsigned int obj_index,
#if deal_II_dimension >= 3
template
-unsigned int
+types::global_dof_index
DoFHandler<deal_II_dimension,deal_II_dimension>::
get_dof_index<3> (const unsigned int obj_level,
const unsigned int obj_index,
void
DoFHandler<deal_II_dimension,deal_II_dimension>::
set_dof_index<1> (const unsigned int obj_level,
- const unsigned int obj_index,
- const unsigned int fe_index,
- const unsigned int local_index,
- const unsigned int global_index) const;
+ const unsigned int obj_index,
+ const unsigned int fe_index,
+ const unsigned int local_index,
+ const types::global_dof_index global_index) const;
#if deal_II_dimension < 3
template
void
DoFHandler<deal_II_dimension,deal_II_dimension+1>::
set_dof_index<1> (const unsigned int obj_level,
- const unsigned int obj_index,
- const unsigned int fe_index,
- const unsigned int local_index,
- const unsigned int global_index) const;
+ const unsigned int obj_index,
+ const unsigned int fe_index,
+ const unsigned int local_index,
+ const types::global_dof_index global_index) const;
#endif
#if deal_II_dimension < 2
void
DoFHandler<deal_II_dimension,deal_II_dimension+2>::
set_dof_index<1> (const unsigned int obj_level,
- const unsigned int obj_index,
- const unsigned int fe_index,
- const unsigned int local_index,
- const unsigned int global_index) const;
+ const unsigned int obj_index,
+ const unsigned int fe_index,
+ const unsigned int local_index,
+ const types::global_dof_index global_index) const;
#endif
#if deal_II_dimension >= 2
void
DoFHandler<deal_II_dimension,deal_II_dimension>::
set_dof_index<2> (const unsigned int obj_level,
- const unsigned int obj_index,
- const unsigned int fe_index,
- const unsigned int local_index,
- const unsigned int global_index) const;
+ const unsigned int obj_index,
+ const unsigned int fe_index,
+ const unsigned int local_index,
+ const types::global_dof_index global_index) const;
#if deal_II_dimension < 3
template
void
DoFHandler<deal_II_dimension,deal_II_dimension+1>::
set_dof_index<2> (const unsigned int obj_level,
- const unsigned int obj_index,
- const unsigned int fe_index,
- const unsigned int local_index,
- const unsigned int global_index) const;
+ const unsigned int obj_index,
+ const unsigned int fe_index,
+ const unsigned int local_index,
+ const types::global_dof_index global_index) const;
#endif
#if deal_II_dimension >= 3
void
DoFHandler<deal_II_dimension,deal_II_dimension>::
set_dof_index<3> (const unsigned int obj_level,
- const unsigned int obj_index,
- const unsigned int fe_index,
- const unsigned int local_index,
- const unsigned int global_index) const;
+ const unsigned int obj_index,
+ const unsigned int fe_index,
+ const unsigned int local_index,
+ const types::global_dof_index global_index) const;
#endif
#endif
}
const unsigned int obj_index,
const unsigned int fe_index,
const unsigned int local_index,
- const unsigned int global_index);
+ const types::global_dof_index global_index);
#endif
#if (deal_II_dimension == 3) && (structdim < 3)
template
- unsigned int
+ types::global_dof_index
DoFObjects<structdim>::
get_dof_index (const dealii::DoFHandler<1,3> &dof_handler,
const unsigned int obj_index,
// innocent block of code. basically, it must be the
// ConstraintMatrix::add_entry call which takes the bulk of the time,
// but it is not known to the author how to make it faster...
- std::vector<std::pair<unsigned int,double> > constraint_line;
- for (unsigned int global_dof=0; global_dof<n_fine_dofs; ++global_dof)
+ std::vector<std::pair<types::global_dof_index,double> > constraint_line;
+ for (types::global_dof_index global_dof=0; global_dof<n_fine_dofs; ++global_dof)
if (weight_mapping[global_dof] != -1)
// this global dof is a parameter dof, so it may carry a constraint
// note that for each global dof, the sum of weights shall be one,
const std::map<unsigned int,float>::const_iterator
j = weights[row].find(col);
if ((j != weights[row].end()) && (j->second != 0))
- constraint_line.push_back (std::pair<unsigned int,double>(representants[row],
- j->second));
+ constraint_line.push_back (std::pair<types::global_dof_index,double>(representants[row],
+ j->second));
};
constraints.add_entries (global_dof, constraint_line);
(const VEC&, std::vector<float>&) const;
template
void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_values<VEC>
- (const VEC&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<double>&) const;
+ (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<double>&) const;
template
void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_values<VEC>
- (const VEC&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<float>&) const;
+ (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<float>&) const;
template
void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_values<VEC>
template
void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_values<VEC>
- (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<Vector<double> > &) const;
template
void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_values<VEC>
- (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<Vector<float> > &) const;
template
void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_values<VEC>
- (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
VectorSlice<std::vector<std::vector<double> > >, bool) const;
// template
// void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_values<VEC>
-// (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+// (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
// VectorSlice<std::vector<std::vector<float> > >, bool) const;
template
(const VEC&, std::vector<Tensor<1,deal_II_space_dimension> > &) const;
template
void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_gradients<VEC>
- (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<Tensor<1,deal_II_space_dimension> > &) const;
template
(const VEC&, std::vector<std::vector<Tensor<1,deal_II_space_dimension> > > &) const;
template
void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_gradients<VEC>
- (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
VectorSlice<std::vector<std::vector<Tensor<1,deal_II_space_dimension> > > >, bool) const;
template
(const VEC&, std::vector<Tensor<2,deal_II_space_dimension> > &) const;
template
void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_hessians<VEC>
- (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<Tensor<2,deal_II_space_dimension> > &) const;
template
(const VEC&, std::vector<std::vector<Tensor<2,deal_II_space_dimension> > > &, bool) const;
template
void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_hessians<VEC>
- (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
VectorSlice<std::vector<std::vector<Tensor<2,deal_II_space_dimension> > > >, bool) const;
template
(const VEC&, std::vector<float>&) const;
template
void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_laplacians<VEC>
- (const VEC&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<double>&) const;
+ (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<double>&) const;
template
void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_laplacians<VEC>
- (const VEC&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<float>&) const;
+ (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<float>&) const;
template
void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_laplacians<VEC>
template
void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_laplacians<VEC>
- (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<Vector<double> > &) const;
template
void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_laplacians<VEC>
- (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<Vector<float> > &) const;
template
void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_laplacians<VEC>
- (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<std::vector<double> > &, bool) const;
template
void FEValuesBase<deal_II_dimension,deal_II_space_dimension>::get_function_laplacians<VEC>
- (const VEC&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const VEC&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<std::vector<float> > &, bool) const;
#endif
(const IndexSet&, std::vector<float>&) const;
template
void FEValuesBase<deal_II_dimension>::get_function_values<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<double>&) const;
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<double>&) const;
template
void FEValuesBase<deal_II_dimension>::get_function_values<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<float>&) const;
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<float>&) const;
template
void FEValuesBase<deal_II_dimension>::get_function_values<IndexSet>
template
void FEValuesBase<deal_II_dimension>::get_function_values<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<Vector<double> > &) const;
template
void FEValuesBase<deal_II_dimension>::get_function_values<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<Vector<float> > &) const;
template
void FEValuesBase<deal_II_dimension>::get_function_values<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
VectorSlice<std::vector<std::vector<double> > >, bool) const;
// template
// void FEValuesBase<deal_II_dimension>::get_function_values<IndexSet>
-// (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+// (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
// VectorSlice<std::vector<std::vector<float> > >, bool) const;
template
(const IndexSet&, std::vector<Tensor<1,deal_II_dimension> > &) const;
template
void FEValuesBase<deal_II_dimension>::get_function_gradients<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<Tensor<1,deal_II_dimension> > &) const;
template
(const IndexSet&, std::vector<std::vector<Tensor<1,deal_II_dimension> > > &) const;
template
void FEValuesBase<deal_II_dimension>::get_function_gradients<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
VectorSlice<std::vector<std::vector<Tensor<1,deal_II_dimension> > > >, bool) const;
template
(const IndexSet&, std::vector<Tensor<2,deal_II_dimension> > &) const;
template
void FEValuesBase<deal_II_dimension>::get_function_hessians<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<Tensor<2,deal_II_dimension> > &) const;
template
(const IndexSet&, std::vector<std::vector<Tensor<2,deal_II_dimension> > > &, bool) const;
template
void FEValuesBase<deal_II_dimension>::get_function_hessians<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
VectorSlice<std::vector<std::vector<Tensor<2,deal_II_dimension> > > >, bool) const;
template
(const IndexSet&, std::vector<float>&) const;
template
void FEValuesBase<deal_II_dimension>::get_function_laplacians<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<double>&) const;
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<double>&) const;
template
void FEValuesBase<deal_II_dimension>::get_function_laplacians<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<float>&) const;
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<float>&) const;
template
void FEValuesBase<deal_II_dimension>::get_function_laplacians<IndexSet>
template
void FEValuesBase<deal_II_dimension>::get_function_laplacians<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<Vector<double> > &) const;
template
void FEValuesBase<deal_II_dimension>::get_function_laplacians<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<Vector<float> > &) const;
template
void FEValuesBase<deal_II_dimension>::get_function_laplacians<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<std::vector<double> > &, bool) const;
template
void FEValuesBase<deal_II_dimension>::get_function_laplacians<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<std::vector<float> > &, bool) const;
(const IndexSet&, std::vector<float>&) const;
template
void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_values<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<double>&) const;
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<double>&) const;
template
void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_values<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<float>&) const;
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<float>&) const;
template
void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_values<IndexSet>
template
void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_values<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<Vector<double> > &) const;
template
void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_values<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<Vector<float> > &) const;
template
void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_values<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
VectorSlice<std::vector<std::vector<double> > >, bool) const;
// template
// void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_values<IndexSet>
-// (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+// (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
// VectorSlice<std::vector<std::vector<float> > >, bool) const;
template
(const IndexSet&, std::vector<Tensor<1,deal_II_dimension+1> > &) const;
template
void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_gradients<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<Tensor<1,deal_II_dimension+1> > &) const;
template
(const IndexSet&, std::vector<std::vector<Tensor<1,deal_II_dimension+1> > > &) const;
template
void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_gradients<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
VectorSlice<std::vector<std::vector<Tensor<1,deal_II_dimension+1> > > >, bool) const;
template
(const IndexSet&, std::vector<Tensor<2,deal_II_dimension+1> > &) const;
template
void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_hessians<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<Tensor<2,deal_II_dimension+1> > &) const;
template
(const IndexSet&, std::vector<std::vector<Tensor<2,deal_II_dimension+1> > > &, bool) const;
template
void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_hessians<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
VectorSlice<std::vector<std::vector<Tensor<2,deal_II_dimension+1> > > >, bool) const;
template
(const IndexSet&, std::vector<float>&) const;
template
void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_laplacians<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<double>&) const;
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<double>&) const;
template
void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_laplacians<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&, std::vector<float>&) const;
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&, std::vector<float>&) const;
template
void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_laplacians<IndexSet>
template
void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_laplacians<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<Vector<double> > &) const;
template
void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_laplacians<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<Vector<float> > &) const;
template
void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_laplacians<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<std::vector<double> > &, bool) const;
template
void FEValuesBase<deal_II_dimension,deal_II_dimension+1>::get_function_laplacians<IndexSet>
- (const IndexSet&, const VectorSlice<const std::vector<unsigned int> >&,
+ (const IndexSet&, const VectorSlice<const std::vector<types::global_dof_index> >&,
std::vector<std::vector<float> > &, bool) const;
#endif
const S1) const;
template void ChunkSparseMatrix<S1>::
PSOR<S2> (Vector<S2> &,
- const std::vector<unsigned int>&,
- const std::vector<unsigned int>&,
+ const std::vector<types::global_dof_index>&,
+ const std::vector<types::global_dof_index>&,
const S1) const;
template void ChunkSparseMatrix<S1>::
TPSOR<S2> (Vector<S2> &,
- const std::vector<unsigned int>&,
- const std::vector<unsigned int>&,
+ const std::vector<types::global_dof_index>&,
+ const std::vector<types::global_dof_index>&,
const S1) const;
template void ChunkSparseMatrix<S1>::
SOR_step<S2> (Vector<S2> &,
// const S1) const;
// template void ChunkSparseMatrix<S1>::
// PSOR<S2> (Vector<S2> &,
-// const std::vector<unsigned int>&,
-// const std::vector<unsigned int>&,
+// const std::vector<types::global_dof_index>&,
+// const std::vector<types::global_dof_index>&,
// const S1) const;
// template void ChunkSparseMatrix<S1>::
// TPSOR<S2> (Vector<S2> &,
-// const std::vector<unsigned int>&,
-// const std::vector<unsigned int>&,
+// const std::vector<types::global_dof_index>&,
+// const std::vector<types::global_dof_index>&,
// const S1) const;
// template void ChunkSparseMatrix<S1>::
// SOR_step<S2> (Vector<S2> &,
ExcInternalError());
if (n_new_entries > entries.size())
{
- std::vector<unsigned int> new_entries;
+ std::vector<types::global_dof_index> new_entries;
new_entries.reserve (n_new_entries);
unsigned int cache_position = 0;
unsigned int entry_position = 0;
ExcInternalError());
if (n_new_entries > entries.size())
{
- std::vector<unsigned int> new_entries;
+ std::vector<types::global_dof_index> new_entries;
new_entries.reserve (n_new_entries);
ForwardIterator my_it = begin;
unsigned int entry_position = 0;
template void ConstraintMatrix::condense<V1 >(const V1 &, V1&) const;
template void ConstraintMatrix::condense<V1 >(V1 &vec) const;
template void ConstraintMatrix::distribute_local_to_global<V1 > (
- const Vector<double>&, const std::vector<unsigned int> &, V1&, const FullMatrix<double>&) const;
+ const Vector<double>&, const std::vector<types::global_dof_index> &, V1&, const FullMatrix<double>&) const;
template void ConstraintMatrix::distribute<V1 >(const V1 &, V1&) const;
template void ConstraintMatrix::distribute<V1 >(V1 &) const;
EOT
std::ostream&, const unsigned int, const unsigned int) const;
template void FullMatrix<S>::copy_from<1>(
- const Tensor<2,1>&, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned);
+ const Tensor<2,1>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type);
template void FullMatrix<S>::copy_from<2>(
- const Tensor<2,2>&, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned);
+ const Tensor<2,2>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type);
template void FullMatrix<S>::copy_from<3>(
- const Tensor<2,3>&, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned);
+ const Tensor<2,3>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type);
template void FullMatrix<S>::copy_to<1>(
- Tensor<2,1>&, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned) const;
+ Tensor<2,1>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type) const;
template void FullMatrix<S>::copy_to<2>(
- Tensor<2,2>&, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned) const;
+ Tensor<2,2>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type) const;
template void FullMatrix<S>::copy_to<3>(
- Tensor<2,3>&, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned, const unsigned) const;
+ Tensor<2,3>&, const size_type, const size_type, const size_type, const size_type, const size_type, const size_type) const;
}
for (S1, S2 : REAL_SCALARS)
void
-SparseDirectMA47::call_ma47id (double *CNTL, // length 2
- unsigned int *ICNTL) // length 7
+SparseDirectMA47::call_ma47id (double *CNTL, // length 2
+ size_type *ICNTL) // length 7
{
HSL::MA47::ma47id_ (CNTL, ICNTL);
}
SparseMatrix<double> &matrix,
const FunctionMap<deal_II_space_dimension>::type &rhs,
Vector<double> &rhs_vector,
- std::vector<unsigned int> &dof_to_boundary_mapping,
+ std::vector<types::global_dof_index> &dof_to_boundary_mapping,
const Function<deal_II_space_dimension> * const a,
std::vector<unsigned int>);
SparseMatrix<double> &matrix,
const FunctionMap<deal_II_space_dimension>::type &rhs,
Vector<double> &rhs_vector,
- std::vector<unsigned int> &dof_to_boundary_mapping,
+ std::vector<types::global_dof_index> &dof_to_boundary_mapping,
const Function<deal_II_space_dimension> * const a,
std::vector<unsigned int>);
SparseMatrix<double>&,
const FunctionMap<deal_II_dimension>::type&,
Vector<double>&,
- std::vector<unsigned int>&,
+ std::vector<types::global_dof_index>&,
const Function<deal_II_dimension> * const,
std::vector<unsigned int>);
SparseMatrix<double>&,
const FunctionMap<deal_II_dimension>::type&,
Vector<double>&,
- std::vector<unsigned int>&,
+ std::vector<types::global_dof_index>&,
const Function<deal_II_dimension> * const,
std::vector<unsigned int>);
n_dofs_old=dof_handler->n_dofs();
// efficient reallocation of indices_on_cell
- std::vector<std::vector<unsigned int> > (n_active_cells)
+ std::vector<std::vector<types::global_dof_index> > (n_active_cells)
.swap(indices_on_cell);
typename DH::active_cell_iterator cell = dof_handler->begin_active(),
// allocate the needed memory. initialize
// the following arrays in an efficient
// way, without copying much
- std::vector<std::vector<unsigned int> >
+ std::vector<std::vector<types::global_dof_index> >
(n_cells_to_stay_or_refine)
.swap(indices_on_cell);
if (pointerstruct!=cell_map_end)
{
- const std::vector<unsigned int> *const indexptr
+ const std::vector<types::global_dof_index> *const indexptr
=pointerstruct->second.indices_ptr;
const std::vector<Vector<typename VECTOR::value_type> > *const valuesptr
const MGDoFHandler<deal_II_dimension> &,
const types::boundary_id,
const Function<deal_II_dimension> &,
- std::map<unsigned int,double> &,
+ std::map<types::global_dof_index,double> &,
const ComponentMask &);
\}
}
(const Mapping<deal_II_dimension,deal_II_space_dimension> &,
const DH<deal_II_dimension,deal_II_space_dimension> &,
const FunctionMap<deal_II_space_dimension>::type &,
- std::map<unsigned int,double> &,
+ std::map<types::global_dof_index,double> &,
const ComponentMask &);
template
const DH<deal_II_dimension,deal_II_space_dimension> &,
const types::boundary_id,
const Function<deal_II_space_dimension> &,
- std::map<unsigned int,double> &,
+ std::map<types::global_dof_index,double> &,
const ComponentMask &);
template
const DH<deal_II_dimension,deal_II_space_dimension> &,
const types::boundary_id,
const Function<deal_II_space_dimension> &,
- std::map<unsigned int,double> &,
+ std::map<types::global_dof_index,double> &,
const ComponentMask &);
template
void interpolate_boundary_values
(const DH<deal_II_dimension,deal_II_space_dimension> &,
const FunctionMap<deal_II_space_dimension>::type &,
- std::map<unsigned int,double> &,
+ std::map<types::global_dof_index,double> &,
const ComponentMask &);
template
const DoFHandler<deal_II_dimension> &,
const FunctionMap<deal_II_dimension>::type &,
const Quadrature<deal_II_dimension-1>&,
- std::map<unsigned int,double>&, std::vector<unsigned int>);
+ std::map<types::global_dof_index,double>&, std::vector<unsigned int>);
#endif
template
(const DoFHandler<deal_II_dimension> &,
const FunctionMap<deal_II_dimension>::type &,
const Quadrature<deal_II_dimension-1>&,
- std::map<unsigned int,double>&, std::vector<unsigned int>);
+ std::map<types::global_dof_index,double>&, std::vector<unsigned int>);
template