BRUNO include/deal.II/meshworker/simple.h
BRUNO include/deal.II/meshworker/vector_selector.h
BRUNO include/deal.II/meshworker/vector_selector.templates.h
-include/deal.II/multigrid/mg_base.h
-include/deal.II/multigrid/mg_block_smoother.h
-include/deal.II/multigrid/mg_coarse.h
-include/deal.II/multigrid/mg_constrained_dofs.h
+KAINAN include/deal.II/multigrid/mg_base.h
+KAINAN include/deal.II/multigrid/mg_block_smoother.h
+KAINAN include/deal.II/multigrid/mg_coarse.h
+KAINAN include/deal.II/multigrid/mg_constrained_dofs.h
include/deal.II/multigrid/mg_dof_accessor.h
include/deal.II/multigrid/mg_dof_handler.h
include/deal.II/multigrid/mg_dof_iterator_selector.h
class MGConstrainedDoFs : public Subscriptor
{
public:
+
+ typedef std::vector<std::set<types::global_dof_index> >::size_type size_dof;
/**
* Fill the internal data
* structures with values
* constraint.
*/
bool is_boundary_index (const unsigned int level,
- const unsigned int index) const;
+ const types::global_dof_index index) const;
/**
* Determine whether a dof index
* a refinement edge.
*/
bool non_refinement_edge_index (const unsigned int level,
- const unsigned int index) const;
+ const types::global_dof_index index) const;
/**
* Determine whether a dof index
* is at the refinement edge.
*/
bool at_refinement_edge (const unsigned int level,
- const unsigned int index) const;
+ const types::global_dof_index index) const;
/**
* Determine whether a dof index
* constraint .
*/
bool at_refinement_edge_boundary (const unsigned int level,
- const unsigned int index) const;
+ const types::global_dof_index index) const;
/**
* Return the indices of dofs for each
* level that lie on the boundary of the
* domain.
*/
- const std::vector<std::set<unsigned int> > &
+ const std::vector<std::set<types::global_dof_index> > &
get_boundary_indices () const;
/**
* level that lie on the boundary of the
* domain.
*/
- const std::vector<std::set<unsigned int> > &
+ const std::vector<std::set<types::global_dof_index> > &
get_non_refinement_edge_indices () const;
/**
* The indices of boundary dofs
* for each level.
*/
- std::vector<std::set<unsigned int> > boundary_indices;
+ std::vector<std::set<types::global_dof_index> > boundary_indices;
/**
* The degrees of freedom on egdges
* refinement edge between a
* level and coarser cells.
*/
- std::vector<std::set<unsigned int> > non_refinement_edge_indices;
+ std::vector<std::set<types::global_dof_index> > non_refinement_edge_indices;
/**
* The degrees of freedom on the
inline
bool
MGConstrainedDoFs::is_boundary_index (const unsigned int level,
- const unsigned int index) const
+ const types::global_dof_index index) const
{
AssertIndexRange(level, boundary_indices.size());
if (boundary_indices[level].find(index) != boundary_indices[level].end())
inline
bool
MGConstrainedDoFs::non_refinement_edge_index (const unsigned int level,
- const unsigned int index) const
+ const types::global_dof_index index) const
{
AssertIndexRange(level, non_refinement_edge_indices.size());
inline
bool
MGConstrainedDoFs::at_refinement_edge (const unsigned int level,
- const unsigned int index) const
+ const types::global_dof_index index) const
{
AssertIndexRange(level, refinement_edge_indices.size());
AssertIndexRange(index, refinement_edge_indices[level].size());
inline
bool
MGConstrainedDoFs::at_refinement_edge_boundary (const unsigned int level,
- const unsigned int index) const
+ const types::global_dof_index index) const
{
AssertIndexRange(level, refinement_edge_boundary_indices.size());
AssertIndexRange(index, refinement_edge_boundary_indices[level].size());
}
inline
-const std::vector<std::set<unsigned int> > &
+const std::vector<std::set<types::global_dof_index> > &
MGConstrainedDoFs::get_boundary_indices () const
{
return boundary_indices;
}
inline
-const std::vector<std::set<unsigned int> > &
+const std::vector<std::set<types::global_dof_index> > &
MGConstrainedDoFs::get_non_refinement_edge_indices () const
{
return non_refinement_edge_indices;