FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
BodyForce<dim> body_force;
std::vector<Vector<double> > body_force_values (n_q_points,
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
// Next, we again have to loop over all
// cells and assemble local contributions.
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
const FEValuesExtractors::Vector displacement (0);
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
typename DoFHandler<dim>::active_cell_iterator cell = dof_handler.begin_active(),
endc = dof_handler.end();
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
// Here is one difference: for this
// program, we will again use a
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
const Coefficient<dim> coefficient;
std::vector<double> coefficient_values (n_q_points);
#endif
+
+ template <typename Integer>
+ std::vector<Integer>
+ reverse_permutation (const std::vector<Integer> &permutation)
+ {
+ const unsigned int n = permutation.size();
+
+ std::vector<Integer> out (n);
+ for (unsigned int i=0; i<n; ++i)
+ out[i] = n - 1 - permutation[i];
+
+ return out;
+ }
+
+
+
+ template <typename Integer>
+ std::vector<Integer>
+ invert_permutation (const std::vector<Integer> &permutation)
+ {
+ const unsigned int n = permutation.size();
+
+ std::vector<Integer> out (n, numbers::invalid_unsigned_int);
+
+ for (unsigned 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 int i=0; i<n; ++i)
+ Assert (out[i] != numbers::invalid_unsigned_int,
+ ExcMessage ("The given input permutation had duplicate entries!"));
+
+ return out;
+ }
+
}
template <int dim, class DH>
inline
-unsigned int
+types::global_dof_index
DoFAccessor<dim,DH>::dof_index (const unsigned int i,
const unsigned int fe_index) const
{
template <int structdim, class DH>
inline
-unsigned int
+types::global_dof_index
DoFAccessor<structdim, DH>::vertex_dof_index (const unsigned int vertex,
const unsigned int i,
const unsigned int fe_index) const
template <template <int, int> class DH, int spacedim>
inline
-unsigned int
+types::global_dof_index
DoFAccessor<0,DH<1,spacedim> >::
vertex_dof_index (const unsigned int vertex,
const unsigned int i,
inline
void
DoFCellAccessor<DH>::
-get_dof_indices (std::vector<unsigned int> &dof_indices) const
+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."));
* respective degree of freedom shall be assigned. This number may, for
* example, be obtained by sorting the support points of the degrees of
* freedom in downwind direction. Then call the
- * <tt>renumber_dofs(vector<unsigned int>)</tt> function with the array, which
+ * <tt>renumber_dofs(vector<types::global_dof_index>)</tt> function with the array, which
* converts old into new degree of freedom indices.
*
*
template <int dim, int spacedim>
inline
-unsigned int
+types::global_dof_index
DoFHandler<dim,spacedim>::n_dofs () const
{
return number_cache.n_global_dofs;
}
template <int dim, int spacedim>
-unsigned int
+types::global_dof_index
DoFHandler<dim, spacedim>::n_locally_owned_dofs() const
{
return number_cache.n_locally_owned_dofs;
template <int dim, int spacedim>
-const std::vector<unsigned int> &
+const std::vector<types::global_dof_index> &
DoFHandler<dim, spacedim>::n_locally_owned_dofs_per_processor() const
{
return number_cache.n_locally_owned_dofs_per_processor;
* Store the global indices of
* the degrees of freedom.
*/
- std::vector<unsigned int> dofs;
+ std::vector<types::global_dof_index> dofs;
public:
/**
template <int dim>
template <int dh_dim, int spacedim>
inline
- unsigned int
+ types::global_dof_index
DoFObjects<dim>::
get_dof_index (const dealii::DoFHandler<dh_dim,spacedim> &dof_handler,
const unsigned int obj_index,
void compute_block_renumbering (
const FiniteElement<dim,spacedim>& fe,
std::vector<unsigned int>& renumbering,
- std::vector<unsigned int>& block_data,
+ std::vector<types::global_dof_index>& block_data,
bool return_start_indices = true);
/**
template <int dim, int spacedim>
inline
-unsigned int MGDoFHandler<dim,spacedim>::n_dofs() const
+types::global_dof_index MGDoFHandler<dim,spacedim>::n_dofs() const
{
return DoFHandler<dim,spacedim>::n_dofs();
}
template <int dim, int spacedim>
inline
-void MGDoFHandler<dim,spacedim>::renumber_dofs (const std::vector<unsigned int> &new_numbers)
+void MGDoFHandler<dim,spacedim>::renumber_dofs (const std::vector<types::global_dof_index> &new_numbers)
{
return DoFHandler<dim,spacedim>::renumber_dofs (new_numbers);
}
template <int dim, int spacedim>
inline
-unsigned int
+types::global_dof_index
MGDoFHandler<dim,spacedim>::MGVertexDoFs::get_index (const unsigned int level,
const unsigned int dof_number,
const unsigned int dofs_per_vertex) const {
next = i;
++next;
- unsigned int first_index = i->begin;
- unsigned int last_index = i->end;
+ types::global_dof_index first_index = i->begin;
+ types::global_dof_index last_index = i->end;
// see if we can merge any of
// the following ranges
void
IndexSet::read(std::istream & in)
{
- unsigned int s, numranges, b, e;
+ types::global_dof_index s;
+ unsigned int numranges;
+
in >> s >> numranges;
ranges.clear();
set_size(s);
for (unsigned int i=0;i<numranges;++i)
{
+ types::global_dof_index b, e;
in >> b >> e;
add_range(b,e);
}
void
IndexSet::block_read(std::istream & in)
{
- unsigned int size;
+ types::global_dof_index size;
size_t n_ranges;
in.read(reinterpret_cast<char*>(&size), sizeof(size));
in.read(reinterpret_cast<char*>(&n_ranges), sizeof(n_ranges));
}
-void IndexSet::fill_index_vector(std::vector<unsigned int> & indices) const
+void IndexSet::fill_index_vector(std::vector<types::global_dof_index> & indices) const
{
compress();
for (std::vector<Range>::iterator it = ranges.begin();
it != ranges.end();
++it)
- for (unsigned int i=it->begin; i<it->end; ++i)
+ for (types::global_dof_index i=it->begin; i<it->end; ++i)
indices.push_back (i);
Assert (indices.size() == n_elements(), ExcInternalError());
std::size_t
IndexSet::memory_consumption () const
{
- return MemoryConsumption::memory_consumption (ranges) +
- MemoryConsumption::memory_consumption (is_compressed) +
- MemoryConsumption::memory_consumption (index_space_size);
+ return (MemoryConsumption::memory_consumption (ranges) +
+ MemoryConsumption::memory_consumption (is_compressed) +
+ MemoryConsumption::memory_consumption (index_space_size));
}
}
+ template <typename Integer>
+ std::vector<Integer>
+ reverse_permutation (const std::vector<Integer> &permutation)
+ {
+ const unsigned int n = permutation.size();
+
+ std::vector<Integer> out (n);
+ for (unsigned int i=0; i<n; ++i)
+ out[i] = n - 1 - permutation[i];
+
+ return out;
+ }
+
+
+
+ template <typename Integer>
+ std::vector<Integer>
+ invert_permutation (const std::vector<Integer> &permutation)
+ {
+ const unsigned int n = permutation.size();
+
+ std::vector<Integer> out (n, numbers::invalid_unsigned_int);
+
+ for (unsigned 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 int i=0; i<n; ++i)
+ Assert (out[i] != numbers::invalid_unsigned_int,
+ ExcMessage ("The given input permutation had duplicate entries!"));
+
+ return out;
+ }
+
+
+
namespace System
{
template <class DH>
void
-DoFCellAccessor<DH>::set_dof_indices (const std::vector<unsigned int> &local_dof_indices)
+DoFCellAccessor<DH>::set_dof_indices (const std::vector<types::global_dof_index> &local_dof_indices)
{
Assert (static_cast<unsigned int>(this->present_level) < this->dof_handler->levels.size(),
ExcMessage ("DoFHandler not initialized"));
const unsigned int DoFHandler<dim,spacedim>::space_dimension;
template <int dim, int spacedim>
-const unsigned int DoFHandler<dim,spacedim>::invalid_dof_index;
+const types::global_dof_index DoFHandler<dim,spacedim>::invalid_dof_index;
template <int dim, int spacedim>
const unsigned int DoFHandler<dim,spacedim>::default_fe_index;
namespace internal
{
template <int dim, int spacedim>
- const unsigned int * dummy ()
+ const types::global_dof_index * dummy ()
{
return &dealii::DoFHandler<dim,spacedim>::invalid_dof_index;
}
template <>
-unsigned int DoFHandler<1>::n_boundary_dofs () const
+types::global_dof_index DoFHandler<1>::n_boundary_dofs () const
{
return 2*get_fe().dofs_per_vertex;
}
template <>
-unsigned int DoFHandler<1>::n_boundary_dofs (const FunctionMap &boundary_indicators) const
+types::global_dof_index DoFHandler<1>::n_boundary_dofs (const FunctionMap &boundary_indicators) const
{
// check that only boundary
// indicators 0 and 1 are allowed
template <>
-unsigned int DoFHandler<1,2>::n_boundary_dofs () const
+types::global_dof_index DoFHandler<1,2>::n_boundary_dofs () const
{
return 2*get_fe().dofs_per_vertex;
}
template <>
-unsigned int DoFHandler<1,2>::n_boundary_dofs (const FunctionMap &boundary_indicators) const
+types::global_dof_index DoFHandler<1,2>::n_boundary_dofs (const FunctionMap &boundary_indicators) const
{
// check that only boundary
// indicators 0 and 1 are allowed
template<int dim, int spacedim>
-unsigned int DoFHandler<dim,spacedim>::n_boundary_dofs () const
+types::global_dof_index DoFHandler<dim,spacedim>::n_boundary_dofs () const
{
std::set<int> boundary_dofs;
const unsigned int dofs_per_face = get_fe().dofs_per_face;
- std::vector<unsigned int> dofs_on_face(dofs_per_face);
+ std::vector<types::global_dof_index> dofs_on_face(dofs_per_face);
// loop over all faces to check
// whether they are at a
template<int dim, int spacedim>
-unsigned int
+types::global_dof_index
DoFHandler<dim,spacedim>::n_boundary_dofs (const FunctionMap &boundary_indicators) const
{
Assert (boundary_indicators.find(types::internal_face_boundary_id) == boundary_indicators.end(),
std::set<int> boundary_dofs;
const unsigned int dofs_per_face = get_fe().dofs_per_face;
- std::vector<unsigned int> dofs_on_face(dofs_per_face);
+ std::vector<types::global_dof_index> dofs_on_face(dofs_per_face);
active_face_iterator face = begin_active_face (),
endf = end_face();
for (; face!=endf; ++face)
std::set<int> boundary_dofs;
const unsigned int dofs_per_face = get_fe().dofs_per_face;
- std::vector<unsigned int> dofs_on_face(dofs_per_face);
+ std::vector<types::global_dof_index> dofs_on_face(dofs_per_face);
active_face_iterator face = begin_active_face (),
endf = end_face();
for (; face!=endf; ++face)
template <int dim, int spacedim>
void
DoFHandler<dim,spacedim>::
-renumber_dofs (const std::vector<unsigned int> &new_numbers)
+renumber_dofs (const std::vector<types::global_dof_index> &new_numbers)
{
Assert (new_numbers.size() == n_locally_owned_dofs(),
ExcRenumberingIncomplete());
delete faces;
faces = 0;
- std::vector<unsigned int> tmp;
+ std::vector<types::global_dof_index> tmp;
std::swap (vertex_dofs, tmp);
}
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
{
namespace internal
\{
- template const unsigned int * dummy<deal_II_dimension,deal_II_dimension> ();
+ template const types::global_dof_index * dummy<deal_II_dimension,deal_II_dimension> ();
#if deal_II_dimension < 3
- template const unsigned int * dummy<deal_II_dimension,deal_II_dimension+1> ();
+ template const types::global_dof_index * dummy<deal_II_dimension,deal_II_dimension+1> ();
#endif
\}
// $Id$
// Version: $Name$
//
-// Copyright (C) 2006, 2010 by the deal.II authors
+// Copyright (C) 2006, 2010, 2011 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
for (deal_II_dimension, structdim : DIMENSIONS)
{
template
- unsigned int
+ types::global_dof_index
DoFObjects<structdim>::
get_dof_index (const dealii::DoFHandler<deal_II_dimension> &dof_handler,
const unsigned int obj_index,
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);
#if (deal_II_dimension < 3) && (structdim < 3)
template
- unsigned int
+ types::global_dof_index
DoFObjects<structdim>::
get_dof_index (const dealii::DoFHandler<deal_II_dimension,deal_II_dimension+1> &dof_handler,
const unsigned int obj_index,
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
}
Graph G(n);
- std::vector<unsigned int> dofs_on_this_cell;
+ std::vector<dealii::types::global_dof_index> dofs_on_this_cell;
typename DH::active_cell_iterator cell = dof_handler.begin_active(),
endc = dof_handler.end();
dof_handler.max_couplings_between_dofs());
MGTools::make_sparsity_pattern (dof_handler, sparsity, level);
- std::vector<unsigned int> new_indices(sparsity.n_rows());
+ std::vector<types::global_dof_index> new_indices(sparsity.n_rows());
SparsityTools::reorder_Cuthill_McKee (sparsity, new_indices,
starting_indices);
const typename DoFHandler<dim,spacedim>::cell_iterator
end = dof_handler.end();
- const unsigned int result =
+ const types::global_dof_index result =
compute_component_wise<dim, spacedim, ITERATOR,
typename DoFHandler<dim,spacedim>::cell_iterator>
(renumbering, start, end, component_order_arg);
const typename hp::DoFHandler<dim>::cell_iterator
end = dof_handler.end();
- const unsigned int result =
+ const types::global_dof_index result =
compute_component_wise<dim, dim, ITERATOR,
typename hp::DoFHandler<dim>::cell_iterator>(renumbering,
start, end,
iend = dof_handler.end(level);
const ITERATOR end = iend;
- const unsigned int result =
+ const types::global_dof_index result =
compute_component_wise<dim, dim, ITERATOR, ITERATOR>(
renumbering, start, end, component_order_arg);
cell_wise_dg (DH& dof,
const std::vector<typename DH::cell_iterator>& cells)
{
- std::vector<unsigned int> renumbering(dof.n_dofs());
- std::vector<unsigned int> reverse(dof.n_dofs());
+ std::vector<types::global_dof_index> renumbering(dof.n_dofs());
+ std::vector<types::global_dof_index> reverse(dof.n_dofs());
compute_cell_wise_dg(renumbering, reverse, dof, cells);
dof.renumber_dofs(renumbering);
DH& dof,
const std::vector<typename DH::cell_iterator>& cells)
{
- std::vector<unsigned int> renumbering(dof.n_dofs());
- std::vector<unsigned int> reverse(dof.n_dofs());
+ std::vector<types::global_dof_index> renumbering(dof.n_dofs());
+ std::vector<types::global_dof_index> reverse(dof.n_dofs());
compute_cell_wise(renumbering, reverse, dof, cells);
dof.renumber_dofs(renumbering);
template <class DH>
void
compute_cell_wise_dg (
- std::vector<unsigned int>& new_indices,
- std::vector<unsigned int>& reverse,
+ std::vector<types::global_dof_index>& new_indices,
+ std::vector<types::global_dof_index>& reverse,
const DH& dof,
const typename std::vector<typename DH::cell_iterator>& cells)
{
ExcDimensionMismatch(cells.size(),
dof.get_tria().n_active_cells()));
- unsigned int n_global_dofs = dof.n_dofs();
+ types::global_dof_index n_global_dofs = dof.n_dofs();
// Actually, we compute the
// inverse of the reordering
Assert(reverse.size() == n_global_dofs,
ExcDimensionMismatch(reverse.size(), n_global_dofs));
- std::vector<unsigned int> cell_dofs;
+ std::vector<types::global_dof_index> cell_dofs;
- unsigned int global_index = 0;
+ types::global_dof_index global_index = 0;
typename std::vector<typename DH::cell_iterator>::const_iterator cell;
}
Assert(global_index == n_global_dofs, ExcRenumberingIncomplete());
- for (unsigned int i=0;i<reverse.size(); ++i)
+ for (types::global_dof_index i=0;i<reverse.size(); ++i)
new_indices[reverse[i]] = i;
}
template <class DH>
void
compute_cell_wise (
- std::vector<unsigned int>& new_indices,
- std::vector<unsigned int>& reverse,
+ std::vector<types::global_dof_index>& new_indices,
+ std::vector<types::global_dof_index>& reverse,
const DH& dof,
const typename std::vector<typename DH::cell_iterator>& cells)
{
ExcDimensionMismatch(cells.size(),
dof.get_tria().n_active_cells()));
- unsigned int n_global_dofs = dof.n_dofs();
+ types::global_dof_index n_global_dofs = dof.n_dofs();
// Actually, we compute the
// inverse of the reordering
// make sure, that each dof is
// reordered only once.
std::vector<bool> already_sorted(n_global_dofs, false);
- std::vector<unsigned int> cell_dofs;
+ std::vector<types::global_dof_index> cell_dofs;
- unsigned int global_index = 0;
+ types::global_dof_index global_index = 0;
typename std::vector<typename DH::cell_iterator>::const_iterator cell;
}
Assert(global_index == n_global_dofs, ExcRenumberingIncomplete());
- for (unsigned int i=0;i<reverse.size(); ++i)
+ for (types::global_dof_index i=0;i<reverse.size(); ++i)
new_indices[reverse[i]] = i;
}
const unsigned int level,
const typename std::vector<typename MGDoFHandler<dim>::cell_iterator>& cells)
{
- std::vector<unsigned int> renumbering(dof.n_dofs(level));
- std::vector<unsigned int> reverse(dof.n_dofs(level));
+ std::vector<types::global_dof_index> renumbering(dof.n_dofs(level));
+ std::vector<types::global_dof_index> reverse(dof.n_dofs(level));
compute_cell_wise_dg(renumbering, reverse, dof, level, cells);
dof.renumber_dofs(level, renumbering);
const unsigned int level,
const typename std::vector<typename MGDoFHandler<dim>::cell_iterator>& cells)
{
- std::vector<unsigned int> renumbering(dof.n_dofs(level));
- std::vector<unsigned int> reverse(dof.n_dofs(level));
+ std::vector<types::global_dof_index> renumbering(dof.n_dofs(level));
+ std::vector<types::global_dof_index> reverse(dof.n_dofs(level));
compute_cell_wise(renumbering, reverse, dof, level, cells);
dof.renumber_dofs(level, renumbering);
template <int dim>
void compute_cell_wise_dg (
- std::vector<unsigned int>& new_order,
- std::vector<unsigned int>& reverse,
+ std::vector<types::global_dof_index>& new_order,
+ std::vector<types::global_dof_index>& reverse,
const MGDoFHandler<dim>& dof,
const unsigned int level,
const typename std::vector<typename MGDoFHandler<dim>::cell_iterator>& cells)
Assert (reverse.size() == dof.n_dofs(level),
ExcDimensionMismatch(reverse.size(), dof.n_dofs(level)));
- unsigned int n_global_dofs = dof.n_dofs(level);
+ types::global_dof_index n_global_dofs = dof.n_dofs(level);
unsigned int n_cell_dofs = dof.get_fe().n_dofs_per_cell();
- std::vector<unsigned int> cell_dofs(n_cell_dofs);
+ std::vector<types::global_dof_index> cell_dofs(n_cell_dofs);
- unsigned int global_index = 0;
+ types::global_dof_index global_index = 0;
typename std::vector<typename MGDoFHandler<dim>::cell_iterator>::const_iterator cell;
}
Assert(global_index == n_global_dofs, ExcRenumberingIncomplete());
- for (unsigned int i=0;i<new_order.size(); ++i)
+ for (types::global_dof_index i=0;i<new_order.size(); ++i)
new_order[reverse[i]] = i;
}
template <int dim>
void compute_cell_wise (
- std::vector<unsigned int>& new_order,
- std::vector<unsigned int>& reverse,
+ std::vector<types::global_dof_index>& new_order,
+ std::vector<types::global_dof_index>& reverse,
const MGDoFHandler<dim>& dof,
const unsigned int level,
const typename std::vector<typename MGDoFHandler<dim>::cell_iterator>& cells)
Assert (reverse.size() == dof.n_dofs(level),
ExcDimensionMismatch(reverse.size(), dof.n_dofs(level)));
- unsigned int n_global_dofs = dof.n_dofs(level);
+ types::global_dof_index n_global_dofs = dof.n_dofs(level);
unsigned int n_cell_dofs = dof.get_fe().n_dofs_per_cell();
std::vector<bool> already_sorted(n_global_dofs, false);
- std::vector<unsigned int> cell_dofs(n_cell_dofs);
+ std::vector<types::global_dof_index> cell_dofs(n_cell_dofs);
- unsigned int global_index = 0;
+ types::global_dof_index global_index = 0;
typename std::vector<typename MGDoFHandler<dim>::cell_iterator>::const_iterator cell;
}
Assert(global_index == n_global_dofs, ExcRenumberingIncomplete());
- for (unsigned int i=0;i<new_order.size(); ++i)
+ for (types::global_dof_index i=0;i<new_order.size(); ++i)
new_order[reverse[i]] = i;
}
void
downstream_dg (DH& dof, const Point<dim>& direction)
{
- std::vector<unsigned int> renumbering(dof.n_dofs());
+ std::vector<types::global_dof_index> renumbering(dof.n_dofs());
compute_downstream_dg(renumbering, dof, direction);
dof.renumber_dofs(renumbering);
downstream (DH& dof, const Point<dim>& direction,
const bool dof_wise_renumbering)
{
- std::vector<unsigned int> renumbering(dof.n_dofs());
- std::vector<unsigned int> reverse(dof.n_dofs());
+ std::vector<types::global_dof_index> renumbering(dof.n_dofs());
+ std::vector<types::global_dof_index> reverse(dof.n_dofs());
compute_downstream(renumbering, reverse, dof, direction,
dof_wise_renumbering);
template <class DH, int dim>
void
compute_downstream_dg (
- std::vector<unsigned int>& new_indices,
+ std::vector<types::global_dof_index>& new_indices,
const DH& dof,
const Point<dim>& direction)
{
copy (begin, end, ordered_cells.begin());
std::sort (ordered_cells.begin(), ordered_cells.end(), comparator);
- std::vector<unsigned int> reverse(new_indices.size());
+ std::vector<types::global_dof_index> reverse(new_indices.size());
compute_cell_wise_dg(new_indices, reverse, dof, ordered_cells);
}
template <class DH, int dim>
void
compute_downstream_dg (
- std::vector<unsigned int>& new_indices,
- std::vector<unsigned int>& reverse,
+ std::vector<types::global_dof_index>& new_indices,
+ std::vector<types::global_dof_index>& reverse,
const DH& dof,
const Point<dim>& direction)
{
template <class DH, int dim>
void
compute_downstream (
- std::vector<unsigned int>& new_indices,
- std::vector<unsigned int>& reverse,
+ std::vector<types::global_dof_index>& new_indices,
+ std::vector<types::global_dof_index>& reverse,
const DH& dof,
const Point<dim>& direction,
const bool dof_wise_renumbering)
const unsigned int level,
const Point<dim>& direction)
{
- std::vector<unsigned int> renumbering(dof.n_dofs(level));
- std::vector<unsigned int> reverse(dof.n_dofs(level));
+ std::vector<types::global_dof_index> renumbering(dof.n_dofs(level));
+ std::vector<types::global_dof_index> reverse(dof.n_dofs(level));
compute_downstream_dg(renumbering, reverse, dof, level, direction);
dof.renumber_dofs(level, renumbering);
const Point<dim>& direction,
const bool dof_wise_renumbering)
{
- std::vector<unsigned int> renumbering(dof.n_dofs(level));
- std::vector<unsigned int> reverse(dof.n_dofs(level));
+ std::vector<types::global_dof_index> renumbering(dof.n_dofs(level));
+ std::vector<types::global_dof_index> reverse(dof.n_dofs(level));
compute_downstream(renumbering, reverse, dof, level, direction,
dof_wise_renumbering);
template <int dim>
void
compute_downstream_dg (
- std::vector<unsigned int>& new_indices,
- std::vector<unsigned int>& reverse,
+ std::vector<types::global_dof_index>& new_indices,
+ std::vector<types::global_dof_index>& reverse,
const MGDoFHandler<dim>& dof,
const unsigned int level,
const Point<dim>& direction)
template <int dim>
void
compute_downstream (
- std::vector<unsigned int>& new_indices,
- std::vector<unsigned int>& reverse,
+ std::vector<types::global_dof_index>& new_indices,
+ std::vector<types::global_dof_index>& reverse,
const MGDoFHandler<dim>& dof,
const unsigned int level,
const Point<dim>& direction,
const Point<dim>& center,
const bool counter)
{
- std::vector<unsigned int> renumbering(dof.n_dofs());
+ std::vector<types::global_dof_index> renumbering(dof.n_dofs());
compute_clockwise_dg(renumbering, dof, center, counter);
dof.renumber_dofs(renumbering);
template <class DH, int dim>
void
compute_clockwise_dg (
- std::vector<unsigned int>& new_indices,
+ std::vector<types::global_dof_index>& new_indices,
const DH& dof,
const Point<dim>& center,
const bool counter)
std::copy (begin, end, ordered_cells.begin());
std::sort (ordered_cells.begin(), ordered_cells.end(), comparator);
- std::vector<unsigned int> reverse(new_indices.size());
+ std::vector<types::global_dof_index> reverse(new_indices.size());
compute_cell_wise_dg(new_indices, reverse, dof, ordered_cells);
}
template <class DH>
void
compute_random (
- std::vector<unsigned int>& new_indices,
+ std::vector<types::global_dof_index>& new_indices,
const DH& dof_handler)
{
- const unsigned int n_dofs = dof_handler.n_dofs();
+ const types::global_dof_index n_dofs = dof_handler.n_dofs();
Assert(new_indices.size() == n_dofs,
ExcDimensionMismatch(new_indices.size(), n_dofs));
template
void
- compute_Cuthill_McKee (std::vector<unsigned int> &,
+ compute_Cuthill_McKee (std::vector<dealii::types::global_dof_index> &,
const DoFHandler<deal_II_dimension> &, bool, bool);
template
template
void
- compute_king_ordering (std::vector<unsigned int> &,
+ compute_king_ordering (std::vector<dealii::types::global_dof_index> &,
const DoFHandler<deal_II_dimension> &, bool, bool);
template
template
void
- compute_minimum_degree (std::vector<unsigned int> &,
+ compute_minimum_degree (std::vector<dealii::types::global_dof_index> &,
const DoFHandler<deal_II_dimension> &, bool, bool);
template
void
- compute_Cuthill_McKee (std::vector<unsigned int> &,
+ compute_Cuthill_McKee (std::vector<dealii::types::global_dof_index> &,
const hp::DoFHandler<deal_II_dimension> &, bool, bool);
template
template
void
- compute_king_ordering (std::vector<unsigned int> &,
+ compute_king_ordering (std::vector<dealii::types::global_dof_index> &,
const hp::DoFHandler<deal_II_dimension> &, bool, bool);
template
template
void
- compute_minimum_degree (std::vector<unsigned int> &,
+ compute_minimum_degree (std::vector<dealii::types::global_dof_index> &,
const hp::DoFHandler<deal_II_dimension> &, bool, bool);
\}
template void
DoFTools::make_boundary_sparsity_pattern<DoFHandler<deal_II_dimension>,SP>
(const DoFHandler<deal_II_dimension>& 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>,SP>
(const hp::DoFHandler<deal_II_dimension>& 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>,SP>
(const 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
}
}
- std::vector<unsigned int> local_dof_indices (dof_handler->get_fe ().dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dof_handler->get_fe ().dofs_per_cell);
for (unsigned int point = 0; point < locations.size (); point++)
{
current_cell[point]->get_dof_indices (local_dof_indices);
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
std::vector<double> laplace_coefficients (fe_values.n_quadrature_points);
std::vector<double> mass_coefficients (fe_values.n_quadrature_points);
Vector<double> cell_rhs (dofs_per_cell);
std::vector<double> rhs_values (n_q_points);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
typename DoFHandler<dim>::active_cell_iterator
cell = this->dof_handler.begin_active(),
// shape functions at the
// quadrature points:
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
// Finally have a variable in
// which we will sum up the
typename DoFHandler<dim>::active_cell_iterator
cell = dof_handler.begin_active(),
endc = dof_handler.end();
- std::vector<unsigned int> local_dof_indices(fe.dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices(fe.dofs_per_cell);
for (; cell!=endc; ++cell)
{
typename DoFHandler<dim>::active_cell_iterator
cell = dof_handler.begin_active(),
endc = dof_handler.end();
- std::vector<unsigned int> local_dof_indices(fe.dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices(fe.dofs_per_cell);
for (; cell!=endc; ++cell)
{
// loop over all cells, active or
// not
- std::vector<unsigned int> local_dof_indices (fe.dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (fe.dofs_per_cell);
for (typename DoFHandler<dim>::cell_iterator cell=dof_handler.begin();
cell != dof_handler.end(); ++cell)
{
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
const Coefficient<dim> coefficient;
std::vector<double> coefficient_values (n_q_points);
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
for (typename DoFHandler<dim>::active_cell_iterator cell=begin_cell;
cell!=end_cell; ++cell)
Vector<double> cell_rhs (dofs_per_cell);
std::vector<double> rhs_values (n_q_points);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
typename DoFHandler<dim>::active_cell_iterator
cell = this->dof_handler.begin_active(),
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
for (typename DoFHandler<dim>::active_cell_iterator cell=begin_cell;
cell!=end_cell; ++cell)
Vector<double> cell_rhs (dofs_per_cell);
std::vector<double> rhs_values (n_q_points);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
typename DoFHandler<dim>::active_cell_iterator
cell = this->dof_handler.begin_active(),
const unsigned int dofs_per_cell = dof_handler.get_fe().dofs_per_cell;
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
double total_volume = 0;
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
std::vector<double> local_solution_values (n_q_points);
std::vector<Tensor<1,dim> > local_solution_grads (n_q_points);
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
typename DoFHandler<dim>::active_cell_iterator cell = mg_dof_handler.begin_active(),
endc = mg_dof_handler.end();
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
typename MGDoFHandler<dim>::cell_iterator cell = mg_dof_handler.begin(),
endc = mg_dof_handler.end();
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
DoFHandler<2>::active_cell_iterator
cell = dof_handler.begin_active(),
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
typename DoFHandler<dim>::active_cell_iterator cell = dof_handler.begin_active(),
endc = dof_handler.end();
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
const Coefficient<dim> coefficient;
std::vector<double> coefficient_values (n_q_points);
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
const Coefficient<dim> coefficient;
std::vector<double> coefficient_values (n_q_points);
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
FEValues<dim> x_fe_values (*fe, quadrature_formula,
update_values | update_gradients |
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
std::vector<double> lambda_values (n_q_points);
std::vector<double> mu_values (n_q_points);
std::vector< Point<spacedim> > cell_normals_i, cell_normals_j;
- std::vector<unsigned int> local_dof_indices_i (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices_j (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices_i (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices_j (dofs_per_cell);
// std::cout
std::vector< Point<spacedim> > cell_normals(q_iterated.size());
std::vector< Point<spacedim> > cell_tangentials(q_iterated.size());
- std::vector<unsigned int> local_dof_indices (fe_q.dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (fe_q.dofs_per_cell);
typename DoFHandler<spacedim-1, spacedim>::active_cell_iterator
cell = dof_handler_q.begin_active(),
std::vector<double> shape_directional_derivative(dofs_per_cell);
Vector<double> projected_directional_derivative(triangulation.n_cells());
- std::vector<unsigned int> local_dof_indices (fe.dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (fe.dofs_per_cell);
typename DoFHandler<dim, spacedim>::active_cell_iterator
cell = dof_handler.begin_active(),
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
::Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
DoFHandler<2>::active_cell_iterator cell = dof_handler.begin_active(),
endc = dof_handler.end();
FullMatrix<double> local_matrix(dofs_per_cell, dofs_per_cell);
Vector<double> local_rhs(dofs_per_cell);
- std::vector<unsigned int> local_dof_indices(dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices(dofs_per_cell);
const FEValuesExtractors::SymmetricTensor<2> stress(0);
const unsigned int dofs_per_cell = fe.dofs_per_cell;
deallog << "dofs_per_cell: " << fe.dofs_per_cell << std::endl;
- std::vector<unsigned int> local_dof_indices(dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices(dofs_per_cell);
const FEValuesExtractors::SymmetricTensor<2> stress(0);
const FEValuesExtractors::Scalar gamma(n_stress_components);
FullMatrix<double> cell_matrix;
Vector<double> cell_rhs;
- std::vector<unsigned int> local_dof_indices;
+ std::vector<types::global_dof_index> local_dof_indices;
typename hp::DoFHandler<dim>::active_cell_iterator
cell = dof_handler.begin_active(),
FullMatrix<double> cell_matrix;
Vector<double> cell_rhs;
- std::vector<unsigned int> local_dof_indices;
+ std::vector<types::global_dof_index> local_dof_indices;
typename hp::DoFHandler<dim>::active_cell_iterator
cell = dof_handler.begin_active(),
FullMatrix<double> cell_matrix;
Vector<double> cell_rhs;
- std::vector<unsigned int> local_dof_indices;
+ std::vector<types::global_dof_index> local_dof_indices;
typename hp::DoFHandler<dim>::active_cell_iterator
cell = dof_handler.begin_active(),
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
std::vector<double> rhs_values (n_q_points);
typename DoFHandler<dim>::active_cell_iterator
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
std::vector<double> rhs_values (n_q_points);
typename DoFHandler<dim>::active_cell_iterator
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
std::vector<double> rhs_values (n_q_points);
typename DoFHandler<dim>::active_cell_iterator
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
std::vector<double> rhs_values (n_q_points);
typename DoFHandler<dim>::active_cell_iterator
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
std::vector<double> rhs_values (n_q_points);
typename DoFHandler<dim>::active_cell_iterator
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
std::vector<double> rhs_values (n_q_points);
typename DoFHandler<dim>::active_cell_iterator
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
const Coefficient<dim> coefficient;
std::vector<double> coefficient_values (n_q_points);
QGauss<dim> quadrature_formula(2);
FEValues<dim> fe_values(finite_element, quadrature_formula, update_values | update_quadrature_points); // just need local_dof_indices and quadrature_points
- std::vector<unsigned int> local_dof_indices(finite_element.dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices(finite_element.dofs_per_cell);
std::vector<Point<dim> > dof_locations(finite_element.dofs_per_cell);
Vector<double> cell_pole(finite_element.dofs_per_cell);
= dofh.begin_active();
const unsigned int dofs_per_cell = dofh.get_fe().dofs_per_cell;
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
cell_matrix = 0;
cell_rhs = 0;
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
for (typename hp::DoFHandler<dim>::active_cell_iterator cell=begin_cell;
cell!=end_cell; ++cell)
Vector<double> cell_rhs (dofs_per_cell);
std::vector<double> rhs_values (n_q_points);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
typename hp::DoFHandler<dim>::active_cell_iterator
cell = this->dof_handler.begin_active(),
const unsigned int dofs_per_cell = dof_handler.get_fe().dofs_per_cell;
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
double total_volume = 0;
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
std::vector<double> local_solution_values (n_q_points);
std::vector<Tensor<1,dim> > local_solution_grads (n_q_points);
double err_l2 = 0,
err_hdiv = 0;
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
for (; cell!=endc; ++cell)
{
double err_l2 = 0,
err_hdiv = 0;
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
for (; cell!=endc; ++cell)
{
cell = dof_handler.begin_active(),
endc = dof_handler.end();
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
FullMatrix<double> local_matrix (dofs_per_cell, dofs_per_cell);
QGauss<dim> quadrature (3);
cell = dof_handler.begin_active(),
endc = dof_handler.end();
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
FullMatrix<double> local_matrix (dofs_per_cell, dofs_per_cell);
QGauss<dim> quadrature (3);
cell = dof_handler.begin_active(),
endc = dof_handler.end();
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
FullMatrix<double> local_matrix (dofs_per_cell, dofs_per_cell);
QGauss<dim> quadrature (3);
cell = dof_handler.begin_active(),
endc = dof_handler.end();
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
FullMatrix<double> local_matrix (dofs_per_cell, dofs_per_cell);
QGauss<dim> quadrature (3);
cell = dof_handler.begin_active(),
endc = dof_handler.end();
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
FullMatrix<double> local_matrix (dofs_per_cell, dofs_per_cell);
QGauss<dim> quadrature (3);
DoFHandler<2>::active_cell_iterator cell = dof_handler->begin_active(),
endc = dof_handler->end();
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
for (; cell!=endc; ++cell)
{
DoFHandler<2>::active_cell_iterator cell = dof_handler->begin_active(),
endc = dof_handler->end();
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
for (; cell!=endc; ++cell)
{
FullMatrix<double> cell_matrix;
Vector<double> cell_rhs;
- std::vector<unsigned int> local_dof_indices;
+ std::vector<types::global_dof_index> local_dof_indices;
typename hp::DoFHandler<dim>::active_cell_iterator
cell = dof_handler.begin_active(),
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
typename DoFHandler<dim>::active_cell_iterator
cell = dof_handler.begin_active(),
hp::DoFHandler<dim> dof_handler(tria);
dof_handler.distribute_dofs(fe_collection);
- std::vector<unsigned int> local_dof_indices (fe_collection[0].dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (fe_collection[0].dofs_per_cell);
for (typename hp::DoFHandler<dim>::active_cell_iterator
cell=dof_handler.begin_active();
cell!=dof_handler.end(); ++cell)
hp::DoFHandler<dim> dof_handler(tria);
dof_handler.distribute_dofs(fe_collection);
- std::vector<unsigned int> local_dof_indices (fe_collection[0].dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (fe_collection[0].dofs_per_cell);
for (typename hp::DoFHandler<dim>::active_cell_iterator
cell=dof_handler.begin_active();
cell!=dof_handler.end(); ++cell)
hp::DoFHandler<dim> dof_handler(tria);
dof_handler.distribute_dofs(fe_collection);
- std::vector<unsigned int> local_dof_indices (fe_collection[0].dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (fe_collection[0].dofs_per_cell);
for (typename hp::DoFHandler<dim>::active_cell_iterator
cell=dof_handler.begin_active();
cell!=dof_handler.end(); ++cell)
dof_handler.distribute_dofs(fe_collection);
- std::vector<unsigned int> local_dof_indices;
+ std::vector<types::global_dof_index> local_dof_indices;
for (typename hp::DoFHandler<dim>::active_cell_iterator
cell=dof_handler.begin_active();
cell!=dof_handler.end(); ++cell)
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
cell_matrix = 0;
cell_rhs = 0;
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
cell_matrix = 0;
cell_rhs = 0;
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
cell_matrix = 0;
cell_rhs = 0;
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
cell_matrix = 0;
cell_rhs = 0;
dof_handler.distribute_dofs(fe_collection);
- std::vector<unsigned int> local_dof_indices;
+ std::vector<types::global_dof_index> local_dof_indices;
for (typename hp::DoFHandler<dim>::active_cell_iterator
cell=dof_handler.begin_active();
cell!=dof_handler.end(); ++cell)
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
for (typename hp::DoFHandler<dim>::active_cell_iterator cell=begin_cell;
cell!=end_cell; ++cell)
Vector<double> cell_rhs (dofs_per_cell);
std::vector<double> rhs_values (n_q_points);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
typename hp::DoFHandler<dim>::active_cell_iterator
cell = this->dof_handler.begin_active(),
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
hp::DoFHandler<2>::active_cell_iterator
cell = dof_handler.begin_active(),
FullMatrix<double> cell_matrix (max_dofs_per_cell, max_dofs_per_cell);
Vector<double> cell_rhs (max_dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (max_dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (max_dofs_per_cell);
hp::DoFHandler<2>::active_cell_iterator
cell = dof_handler.begin_active(),
FullMatrix<double> cell_matrix (max_dofs_per_cell, max_dofs_per_cell);
Vector<double> cell_rhs (max_dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (max_dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (max_dofs_per_cell);
hp::DoFHandler<2>::active_cell_iterator
cell = dof_handler.begin_active(),
FullMatrix<double> cell_matrix (max_dofs_per_cell, max_dofs_per_cell);
Vector<double> cell_rhs (max_dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (max_dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (max_dofs_per_cell);
hp::DoFHandler<2>::active_cell_iterator
cell = dof_handler.begin_active(),
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
typename hp::DoFHandler<dim>::active_cell_iterator cell = dof_handler.begin_active(),
endc = dof_handler.end();
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
const Coefficient<dim> coefficient;
std::vector<double> coefficient_values (n_q_points);
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
const Coefficient<dim> coefficient;
std::vector<double> coefficient_values (n_q_points);
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
hp::FEValues<dim> x_fe_values (*fe, quadrature_formula,
update_values | update_gradients |
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
std::vector<double> lambda_values (n_q_points);
std::vector<double> mu_values (n_q_points);
= dofh.begin_active();
const unsigned int dofs_per_cell = dofh.get_fe().dofs_per_cell;
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
if (myid==0)
= dofh.begin_active();
const unsigned int dofs_per_cell = dofh.get_fe().dofs_per_cell;
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
for (; cell != dofh.end(); ++cell)
if (cell->is_ghost())
= dofh.begin_active();
const unsigned int dofs_per_cell = dofh.get_fe().dofs_per_cell;
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
for (; cell != dofh.end(); ++cell)
if (!cell->is_artificial())
if (myid==0)
{
- std::vector<unsigned int> local_dof_indices;
+ std::vector<types::global_dof_index> local_dof_indices;
typename DoFHandler<dim>::active_cell_iterator
cell, endc = dofh.end();
if (myid==0)
{
- std::vector<unsigned int> local_dof_indices;
+ std::vector<types::global_dof_index> local_dof_indices;
typename DoFHandler<dim>::active_cell_iterator
cell, endc = dofh.end();
typename MGDoFHandler<dim>::cell_iterator
cell = mgdof.begin(),
endc = mgdof.end();
- std::vector<unsigned int> local_dof_indices (fe.dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (fe.dofs_per_cell);
std::vector<unsigned int> mg_dof_indices (fe.dofs_per_cell);
for (; cell!=endc; ++cell)
{
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
const Coefficient<dim> coefficient;
std::vector<double> coefficient_values (n_q_points);
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
const Coefficient<dim> coefficient;
std::vector<double> coefficient_values (n_q_points);
FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
Vector<double> cell_rhs (dofs_per_cell);
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
typename DoFHandler<dim>::active_cell_iterator
cell = dof_handler.begin_active(),