#include <fe/fe.h>
#include <dofs/dof_renumbering.h>
-#ifdef ENABLE_MULTIGRID
#include <multigrid/mg_dof_handler.h>
#include <multigrid/mg_dof_accessor.h>
#include <multigrid/mg_dof_tools.h>
-#endif
#include <vector>
#include <map>
}
-#ifdef ENABLE_MULTIGRID
template <int dim>
void DoFRenumbering::Cuthill_McKee (
MGDoFHandler<dim> &dof_handler,
// thus needs an own function
dof_handler.renumber_dofs (level, new_indices);
}
-#endif
template <int dim>
}
-#ifdef ENABLE_MULTIGRID
template <int dim>
void DoFRenumbering::cell_wise_dg (
MGDoFHandler<dim>& dof,
dof.renumber_dofs(level, reverse);
}
-#endif
/**
* Provide comparator for DoFCellAccessors
#include <lac/block_sparsity_pattern.h>
#include <lac/vector.h>
-#ifdef ENABLE_MULTIGRID
#include <multigrid/mg_dof_handler.h>
#include <multigrid/mg_dof_accessor.h>
-#endif
#include <algorithm>
#include <numeric>
}
-#ifdef ENABLE_MULTIGRID
template<int dim>
void
DoFTools::extract_level_dofs(const unsigned int level,
selected_dofs[indices[i]] = local_selected_dofs[i];
}
}
-#endif
#if deal_II_dimension != 1
const std::vector<bool>& component_select,
std::vector<bool>& selected_dofs);
-#ifdef ENABLE_MULTIGRID
template void DoFTools::extract_level_dofs<deal_II_dimension>
(const unsigned int level,
const MGDoFHandler<deal_II_dimension>& dof,
const std::vector<bool>& component_select,
std::vector<bool>& selected_dofs);
-#endif
#if deal_II_dimension != 1
template
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <grid/tria_iterator.h>
#include <grid/intergrid_map.h>
-#ifdef ENABLE_MULTIGRID
#include <multigrid/mg_dof_handler.h>
#include <multigrid/mg_dof_accessor.h>
-#endif
// helper function to aquire the number of levels within a grid
template <class GridClass>
template class InterGridMap<Triangulation, deal_II_dimension>;
template class InterGridMap<DoFHandler, deal_II_dimension>;
-#ifdef ENABLE_MULTIGRID
template class InterGridMap<MGDoFHandler, deal_II_dimension>;
-#endif