#include <deal.II/base/thread_management.h>
#include <deal.II/base/utilities.h>
#include <deal.II/base/quadrature_lib.h>
+#include <deal.II/base/types.h>
#include <deal.II/lac/sparsity_pattern.h>
#include <deal.II/lac/sparsity_tools.h>
namespace boost
{
#ifndef DEAL_II_BOOST_GRAPH_COMPILER_BUG
- namespace types
+ namespace boosttypes
{
using namespace ::boost;
using namespace std;
template <class DH>
void create_graph (const DH &dof_handler,
const bool use_constraints,
- types::Graph &graph,
- types::property_map<types::Graph,types::vertex_degree_t>::type &graph_degree)
+ boosttypes::Graph &graph,
+ boosttypes::property_map<boosttypes::Graph,boosttypes::vertex_degree_t>::type &graph_degree)
{
{
// create intermediate sparsity pattern
add_edge (row, csp.column_number (row, col), graph);
}
- types::graph_traits<types::Graph>::vertex_iterator ui, ui_end;
+ boosttypes::graph_traits<boosttypes::Graph>::vertex_iterator ui, ui_end;
graph_degree = get(::boost::vertex_degree, graph);
for (::boost::tie(ui, ui_end) = vertices(graph); ui != ui_end; ++ui)
"compiler error and has been disabled. If you need to use the "
"function, you need to upgrade to a newer version of the compiler."));
#else
- types::Graph
+ boosttypes::Graph
graph(dof_handler.n_dofs());
- types::property_map<types::Graph,types::vertex_degree_t>::type
+ boosttypes::property_map<boosttypes::Graph,boosttypes::vertex_degree_t>::type
graph_degree;
internal::create_graph (dof_handler, use_constraints, graph, graph_degree);
- types::property_map<types::Graph, types::vertex_index_t>::type
+ boosttypes::property_map<boosttypes::Graph, boosttypes::vertex_index_t>::type
index_map = get(::boost::vertex_index, graph);
- std::vector<types::Vertex> inv_perm(num_vertices(graph));
+ std::vector<boosttypes::Vertex> inv_perm(num_vertices(graph));
if (reversed_numbering == false)
::boost::cuthill_mckee_ordering(graph, inv_perm.rbegin(),
get(::boost::vertex_color, graph),
make_degree_map(graph));
- for (types::size_type c = 0; c != inv_perm.size(); ++c)
+ for (boosttypes::size_type c = 0; c != inv_perm.size(); ++c)
new_dof_indices[index_map[inv_perm[c]]] = c;
Assert (std::find (new_dof_indices.begin(), new_dof_indices.end(),
"compiler error and has been disabled. If you need to use the "
"function, you need to upgrade to a newer version of the compiler."));
#else
- types::Graph
+ boosttypes::Graph
graph(dof_handler.n_dofs());
- types::property_map<types::Graph,types::vertex_degree_t>::type
+ boosttypes::property_map<boosttypes::Graph,boosttypes::vertex_degree_t>::type
graph_degree;
internal::create_graph (dof_handler, use_constraints, graph, graph_degree);
- types::property_map<types::Graph, types::vertex_index_t>::type
+ boosttypes::property_map<boosttypes::Graph, boosttypes::vertex_index_t>::type
index_map = get(::boost::vertex_index, graph);
- std::vector<types::Vertex> inv_perm(num_vertices(graph));
+ std::vector<boosttypes::Vertex> inv_perm(num_vertices(graph));
if (reversed_numbering == false)
::boost::king_ordering(graph, inv_perm.rbegin());
else
::boost::king_ordering(graph, inv_perm.begin());
- for (types::size_type c = 0; c != inv_perm.size(); ++c)
+ for (boosttypes::size_type c = 0; c != inv_perm.size(); ++c)
new_dof_indices[index_map[inv_perm[c]]] = c;
Assert (std::find (new_dof_indices.begin(), new_dof_indices.end(),