Fixed unused typedef warnings from GCC 4.9; fixes #8877; fixes #8986

[SVN r85323]
This commit is contained in:
Jeremiah Willcock 2013-08-12 18:14:58 +00:00
parent a5a29bd065
commit be2fc043d1
63 changed files with 6 additions and 158 deletions

View File

@ -118,7 +118,6 @@ int main(int argc, char **argv)
typedef property_map<mygraph_t, edge_weight_t>::type WeightMap;
typedef mygraph_t::vertex_descriptor vertex;
typedef mygraph_t::edge_descriptor edge_descriptor;
typedef mygraph_t::vertex_iterator vertex_iterator;
typedef std::pair<int, int> edge;
// specify data

View File

@ -54,7 +54,6 @@ main()
#endif
// Typedefs
typedef graph_traits < graph_t >::vertex_descriptor Vertex;
typedef graph_traits < graph_t >::vertices_size_type Size;
typedef Size* Iiter;

View File

@ -63,7 +63,6 @@ main()
#endif
// Typedefs
typedef graph_traits<graph_t>::vertex_descriptor Vertex;
typedef graph_traits<graph_t>::vertices_size_type Size;
typedef Size* Iiter;

View File

@ -59,7 +59,6 @@ main()
#endif
// Typedefs
typedef boost::graph_traits < graph_t >::vertex_descriptor Vertex;
typedef size_type* Iiter;
// discover time and finish time properties

View File

@ -26,7 +26,6 @@ main(int, char *[])
property<vertex_distance_t, int,
property<vertex_predecessor_t, vertex_descriptor> > > >,
property<edge_weight_t, int> > graph_t;
typedef graph_traits<graph_t>::edge_descriptor edge_descriptor;
typedef std::pair<int, int> Edge;
const int num_nodes = 5;

View File

@ -22,7 +22,6 @@ main(int, char *[])
typedef adjacency_list < listS, vecS, directedS,
no_property, property < edge_weight_t, int > > graph_t;
typedef graph_traits < graph_t >::vertex_descriptor vertex_descriptor;
typedef graph_traits < graph_t >::edge_descriptor edge_descriptor;
typedef std::pair<int, int> Edge;
const int num_nodes = 5;

View File

@ -26,7 +26,6 @@ main(int, char *[])
typedef adjacency_list < listS, vecS, directedS,
no_property, property < edge_weight_t, int > > graph_t;
typedef graph_traits < graph_t >::vertex_descriptor vertex_descriptor;
typedef graph_traits < graph_t >::edge_descriptor edge_descriptor;
typedef std::pair<int, int> Edge;
const int num_nodes = 5;

View File

@ -76,11 +76,7 @@ int main (int argc, char *argv[]) {
property<vertex_index_t, unsigned int> >,
property<edge_name_t, unsigned int> > Graph;
typedef graph_traits<Graph>::vertex_descriptor Vertex;
typedef graph_traits<Graph>::edge_descriptor Edge;
typedef property_map<Graph, vertex_name_t>::type VertexNameMap;
typedef property_map<Graph, edge_name_t>::type EdgeNameMap;
// Test maximum and unique variants on known graphs
Graph graph_simple1, graph_simple2;

View File

@ -27,7 +27,6 @@ int main()
typedef boost::adjacency_list<boost::vecS, boost::vecS, boost::undirectedS,
boost::no_property, boost::property<boost::edge_weight_t, int> > undirected_graph;
typedef boost::graph_traits<undirected_graph>::vertex_descriptor vertex_descriptor;
typedef boost::property_map<undirected_graph, boost::edge_weight_t>::type weight_map_type;
typedef boost::property_traits<weight_map_type>::value_type weight_type;

View File

@ -41,7 +41,6 @@
int main(int,char*[])
{
using namespace boost;
typedef adjacency_list_traits<vecS, vecS, directedS> Traits;
typedef subgraph< adjacency_list<vecS, vecS, directedS,
property<vertex_color_t, int>, property<edge_index_t, int> > > Graph;

View File

@ -102,8 +102,6 @@ namespace boost {
typedef typename GTraits::vertex_descriptor Vertex;
BOOST_CONCEPT_ASSERT(( ReadWritePropertyMapConcept<DistanceMap, Vertex> ));
BOOST_CONCEPT_ASSERT(( ReadablePropertyMapConcept<WeightMap, Edge> ));
typedef typename property_traits<DistanceMap>::value_type D_value;
typedef typename property_traits<WeightMap>::value_type W_value;
typename GTraits::edge_iterator i, end;

View File

@ -296,7 +296,6 @@ namespace detail { namespace graph {
ShortestPaths shortest_paths)
{
typedef typename graph_traits<Graph>::vertex_iterator vertex_iterator;
typedef typename graph_traits<Graph>::edge_iterator edge_iterator;
typedef typename graph_traits<Graph>::vertex_descriptor vertex_descriptor;
// Initialize centrality
@ -421,7 +420,6 @@ namespace detail { namespace graph {
VertexIndexMap vertex_index)
{
typedef typename graph_traits<Graph>::degree_size_type degree_size_type;
typedef typename graph_traits<Graph>::vertex_descriptor vertex_descriptor;
typedef typename graph_traits<Graph>::edge_descriptor edge_descriptor;
typedef typename mpl::if_c<(is_same<CentralityMap,
dummy_property_map>::value),
@ -457,7 +455,6 @@ namespace detail { namespace graph {
VertexIndexMap vertex_index)
{
typedef typename graph_traits<Graph>::degree_size_type degree_size_type;
typedef typename graph_traits<Graph>::vertex_descriptor vertex_descriptor;
typedef typename graph_traits<Graph>::edge_descriptor edge_descriptor;
typedef typename mpl::if_c<(is_same<CentralityMap,
dummy_property_map>::value),

View File

@ -198,7 +198,6 @@ namespace boost {
/// General types and variables
typedef typename property_traits <PartitionMap>::value_type partition_color_t;
typedef typename graph_traits <Graph>::vertex_descriptor vertex_descriptor_t;
typedef typename graph_traits <Graph>::vertex_iterator vertex_iterator_t;
/// Declare dfs visitor
// detail::empty_recorder recorder;

View File

@ -64,7 +64,6 @@ namespace boost {
BOOST_CONCEPT_ASSERT(( IncidenceGraphConcept<IncidenceGraph> ));
typedef graph_traits<IncidenceGraph> GTraits;
typedef typename GTraits::vertex_descriptor Vertex;
typedef typename GTraits::edge_descriptor Edge;
BOOST_CONCEPT_ASSERT(( BFSVisitorConcept<BFSVisitor, IncidenceGraph> ));
BOOST_CONCEPT_ASSERT(( ReadWritePropertyMapConcept<ColorMap, Vertex> ));
typedef typename property_traits<ColorMap>::value_type ColorValue;

View File

@ -73,7 +73,6 @@ namespace boost
{
typedef typename graph_traits<Graph>::vertex_descriptor vertex_t;
typedef typename graph_traits<Graph>::edge_descriptor edge_t;
typedef typename graph_traits<Graph>::vertex_iterator vertex_iterator_t;
typedef typename PlanarEmbedding::value_type::const_iterator
edge_permutation_iterator_t;

View File

@ -123,7 +123,6 @@ all_closeness_centralities(const Graph& g,
typedef typename property_traits<DistanceMatrixMap>::value_type DistanceMap;
BOOST_CONCEPT_ASSERT(( ReadablePropertyMapConcept<DistanceMap,Vertex> ));
BOOST_CONCEPT_ASSERT(( WritablePropertyMapConcept<CentralityMap,Vertex> ));
typedef typename property_traits<DistanceMap>::value_type Distance;
typedef typename property_traits<CentralityMap>::value_type Centrality;
typename graph_traits<Graph>::vertex_iterator i, end;
@ -147,7 +146,6 @@ all_closeness_centralities(const Graph& g,
BOOST_CONCEPT_ASSERT(( ReadablePropertyMapConcept<DistanceMatrixMap,Vertex> ));
typedef typename property_traits<DistanceMatrixMap>::value_type DistanceMap;
BOOST_CONCEPT_ASSERT(( ReadablePropertyMapConcept<DistanceMap,Vertex> ));
typedef typename property_traits<DistanceMap>::value_type Distance;
typedef typename property_traits<CentralityMap>::value_type Result;
all_closeness_centralities(g, dist, cent, measure_closeness<Result>(g, DistanceMap()));

View File

@ -86,7 +86,7 @@ namespace boost {
typedef typename graph_traits<Graph>::vertex_descriptor Vertex;
BOOST_CONCEPT_ASSERT(( WritablePropertyMapConcept<ComponentMap, Vertex> ));
typedef typename boost::graph_traits<Graph>::directed_category directed;
// typedef typename boost::graph_traits<Graph>::directed_category directed;
// BOOST_STATIC_ASSERT((boost::is_same<directed, undirected_tag>::value));
typedef typename property_traits<ComponentMap>::value_type comp_type;

View File

@ -316,7 +316,6 @@ namespace boost {
core_numbers(Graph& g, CoreMap c, EdgeWeightMap wm, VertexIndexMap vim,
CoreNumVisitor vis)
{
typedef typename graph_traits<Graph>::vertices_size_type size_type;
detail::compute_in_degree_map(g,c,wm);
return detail::core_numbers_dispatch(g,c,wm,vim,vis);
}

View File

@ -75,7 +75,6 @@ namespace boost {
{
//create queue, visitor...don't forget namespaces!
typedef typename property_traits<DegreeMap>::value_type ds_type;
typedef typename graph_traits<Graph>::vertex_descriptor Vertex;
typedef typename boost::sparse::sparse_ordering_queue<Vertex> queue;
typedef typename detail::bfs_rcm_visitor<OutputIterator, queue, DegreeMap> Visitor;
@ -137,7 +136,6 @@ namespace boost {
return permutation;
typedef typename boost::graph_traits<Graph>::vertex_descriptor Vertex;
typedef typename boost::graph_traits<Graph>::vertex_iterator VerIter;
typedef typename property_traits<ColorMap>::value_type ColorValue;
typedef color_traits<ColorValue> Color;
@ -172,7 +170,6 @@ namespace boost {
if (boost::graph::has_no_vertices(G))
return permutation;
typedef out_degree_property_map<Graph> DegreeMap;
std::vector<default_color_type> colors(num_vertices(G));
return cuthill_mckee_ordering(G, permutation,
make_iterator_property_map(&colors[0],

View File

@ -41,7 +41,6 @@ namespace boost {
{
typedef typename graph_traits<Graph>::vertex_descriptor Vertex;
typedef typename property_traits<DistanceMap>::value_type Distance;
typedef typename property_traits<WeightMap>::value_type Weight;
typedef indirect_cmp<DistanceMap, DistanceCompare> DistanceIndirectCompare;
DistanceIndirectCompare
@ -92,7 +91,6 @@ namespace boost {
}
// Examine neighbors of min_vertex
typedef typename graph_traits<Graph>::edge_descriptor Edge;
BGL_FORALL_OUTEDGES_T(min_vertex, current_edge, graph, Graph) {
visitor.examine_edge(current_edge, graph);

View File

@ -151,7 +151,6 @@ namespace boost {
const bgl_named_params<P, T, R>& params,
param_not_found)
{
typedef typename graph_traits<Graph>::edge_descriptor edge_descriptor;
typedef typename graph_traits<Graph>::vertices_size_type size_type;
size_type n = is_default_param(get_param(params, vertex_color)) ?
num_vertices(g) : 1;

View File

@ -282,7 +282,6 @@ fruchterman_reingold_force_directed_layout
Cooling cool,
DisplacementMap displacement)
{
typedef typename Topology::point_type Point;
typedef typename graph_traits<Graph>::vertex_iterator vertex_iterator;
typedef typename graph_traits<Graph>::vertex_descriptor vertex_descriptor;
typedef typename graph_traits<Graph>::edge_iterator edge_iterator;

View File

@ -237,8 +237,6 @@ namespace boost {
template <class Graph, class Vertex>
bool is_adj_dispatch(Graph& g, Vertex a, Vertex b, bidirectional_tag)
{
typedef typename graph_traits<Graph>::edge_descriptor
edge_descriptor;
typename graph_traits<Graph>::adjacency_iterator vi, viend,
adj_found;
boost::tie(vi, viend) = adjacent_vertices(a, g);
@ -265,8 +263,6 @@ namespace boost {
template <class Graph, class Vertex>
bool is_adj_dispatch(Graph& g, Vertex a, Vertex b, directed_tag)
{
typedef typename graph_traits<Graph>::edge_descriptor
edge_descriptor;
typename graph_traits<Graph>::adjacency_iterator vi, viend, found;
boost::tie(vi, viend) = adjacent_vertices(a, g);
#if defined(BOOST_MSVC) && BOOST_MSVC <= 1300 && defined(__SGI_STL_PORT)

View File

@ -208,9 +208,6 @@ void gursoy_atun_refine(const VertexListAndIncidenceGraph& graph,
typedef typename graph_traits<VertexListAndIncidenceGraph>::vertex_iterator
vertex_iterator;
typedef typename graph_traits<VertexListAndIncidenceGraph>::vertex_descriptor
vertex_descriptor;
typedef typename Topology::point_type point_type;
vertex_iterator i, iend;
double diameter_ratio = (double)diameter_final / diameter_initial;
double learning_constant_ratio =
@ -230,6 +227,7 @@ void gursoy_atun_refine(const VertexListAndIncidenceGraph& graph,
vertex_index_map);
for (int round = 0; round < nsteps; ++round) {
double part_done = (double)round / (nsteps - 1);
// fprintf(stderr, "%2d%% done\n", int(rint(part_done * 100.)));
int diameter = (int)(diameter_initial * pow(diameter_ratio, part_done));
double learning_constant =
learning_constant_initial * pow(learning_constant_ratio, part_done);

View File

@ -106,11 +106,8 @@ namespace boost
{
typedef typename graph_traits<Graph>::vertex_descriptor vertex_t;
typedef typename graph_traits<Graph>::vertex_iterator vertex_iterator_t;
typedef typename graph_traits<Graph>::edge_descriptor edge_t;
typedef typename graph_traits<Graph>::edge_iterator edge_iterator_t;
typedef typename graph_traits<Graph>::edges_size_type e_size_t;
typedef typename graph_traits<Graph>::vertices_size_type v_size_t;
typedef std::size_t x_coord_t;
typedef std::size_t y_coord_t;

View File

@ -37,7 +37,6 @@ namespace boost {
typename graph_traits<Graph>::out_edge_iterator ei, ei_end;
Vertex v, w;
typedef typename std::deque<Vertex>::iterator iterator;
typedef typename std::deque<Vertex>::reverse_iterator reverse_iterator;
reverse_iterator rend = Qptr->rend()-index_begin;
@ -86,8 +85,6 @@ namespace boost {
//this function replaces pop_heap, and tracks state information
template <typename Vertex>
void percolate_down(int offset){
typedef typename std::deque<Vertex>::reverse_iterator reverse_iterator;
int heap_last = index_begin + offset;
int heap_first = Qptr->size() - 1;
@ -267,7 +264,6 @@ namespace boost {
return permutation;
typedef typename boost::graph_traits<Graph>::vertex_descriptor Vertex;
typedef typename boost::graph_traits<Graph>::vertex_iterator VerIter;
typedef typename property_traits<ColorMap>::value_type ColorValue;
typedef color_traits<ColorValue> Color;
@ -302,7 +298,6 @@ namespace boost {
if (has_no_vertices(G))
return permutation;
typedef out_degree_property_map<Graph> DegreeMap;
std::vector<default_color_type> colors(num_vertices(G));
return king_ordering(G, permutation,
make_iterator_property_map(&colors[0], index_map,

View File

@ -102,7 +102,6 @@ namespace boost {
{
typedef typename graph_traits<Graph>::vertices_size_type size_type;
typedef typename graph_traits<Graph>::vertex_descriptor vertex_t;
typedef typename property_map<Graph, vertex_index_t>::type index_map_t;
if (num_vertices(g) == 0) return; // Nothing to do in this case
typename graph_traits<Graph>::vertices_size_type
n = num_vertices(g);

View File

@ -118,8 +118,6 @@ namespace boost {
void
maximum_adjacency_search(const Graph& g, WeightMap weights, MASVisitor vis, const typename boost::graph_traits<Graph>::vertex_descriptor start, VertexAssignmentMap assignments, KeyedUpdatablePriorityQueue pq) {
typedef typename boost::graph_traits<Graph>::vertex_descriptor vertex_descriptor;
typedef typename boost::graph_traits<Graph>::vertices_size_type vertices_size_type;
typedef typename boost::graph_traits<Graph>::edge_descriptor edge_descriptor;
typedef typename boost::property_traits<WeightMap>::value_type weight_type;
std::set<vertex_descriptor> assignedVertices;
@ -197,7 +195,7 @@ maximum_adjacency_search(const Graph& g, WeightMap weights, MASVisitor vis, cons
typedef typename boost::graph_traits<Graph>::edge_descriptor edge_descriptor;
BOOST_CONCEPT_ASSERT((boost::Convertible<typename boost::graph_traits<Graph>::directed_category, boost::undirected_tag>));
BOOST_CONCEPT_ASSERT((boost::ReadablePropertyMapConcept<WeightMap, edge_descriptor>));
typedef typename boost::property_traits<WeightMap>::value_type weight_type;
// typedef typename boost::property_traits<WeightMap>::value_type weight_type;
boost::function_requires< MASVisitorConcept<MASVisitor, Graph> >();
BOOST_CONCEPT_ASSERT((boost::ReadWritePropertyMapConcept<VertexAssignmentMap, vertex_descriptor>));
BOOST_CONCEPT_ASSERT((boost::Convertible<vertex_descriptor, typename boost::property_traits<VertexAssignmentMap>::value_type>));

View File

@ -121,7 +121,6 @@ namespace boost {
VertexEquivalencePredicate vertices_equivalent,
bool only_connected_subgraphs)
{
typedef typename graph_traits<GraphFirst>::vertex_descriptor VertexFirst;
typedef typename graph_traits<GraphSecond>::vertex_descriptor VertexSecond;
typedef typename graph_traits<GraphFirst>::edge_descriptor EdgeFirst;

View File

@ -173,7 +173,6 @@ namespace boost
// We build a custom graph in this algorithm.
typedef adjacency_list <vecS, vecS, directedS, no_property, no_property > MSTImpl;
typedef graph_traits<MSTImpl>::edge_descriptor Edge;
typedef graph_traits<MSTImpl>::vertex_descriptor Vertex;
typedef graph_traits<MSTImpl>::vertex_iterator VItr;

View File

@ -41,10 +41,8 @@ namespace boost
typedef typename graph_traits<Graph>::vertex_descriptor vertex_t;
typedef typename graph_traits<Graph>::edge_descriptor edge_t;
typedef typename graph_traits<Graph>::vertex_iterator vertex_iterator_t;
typedef typename graph_traits<Graph>::adjacency_iterator
adjacency_iterator_t;
typedef typename std::pair<vertex_t, vertex_t> vertex_pair_t;
typedef typename property_traits<PlanarEmbedding>::value_type
embedding_value_t;
typedef typename embedding_value_t::const_iterator embedding_iterator_t;

View File

@ -86,8 +86,6 @@ namespace boost {
template <typename Graph, typename WeightMap, typename RandomNumGen>
typename graph_traits<Graph>::edge_descriptor
weighted_random_out_edge(Graph& g, typename graph_traits<Graph>::vertex_descriptor src, WeightMap weight, RandomNumGen& gen) {
typedef graph_traits<Graph> gt;
typedef typename gt::vertex_descriptor vertex_descriptor;
typedef typename property_traits<WeightMap>::value_type weight_type;
weight_type weight_sum(0);
BGL_FORALL_OUTEDGES_T(src, e, g, Graph) {weight_sum += get(weight, e);}

View File

@ -33,7 +33,6 @@ namespace boost {
template <typename Graph, typename PredMap, typename ColorMap, typename NextEdge>
void random_spanning_tree_internal(const Graph& g, typename graph_traits<Graph>::vertex_descriptor s, PredMap pred, ColorMap color, NextEdge next_edge) {
typedef typename graph_traits<Graph>::vertex_descriptor vertex_descriptor;
typedef typename graph_traits<Graph>::edge_descriptor edge_descriptor;
BOOST_ASSERT (num_vertices(g) >= 1); // g must also be undirected (or symmetric) and connected

View File

@ -45,7 +45,6 @@ int read_dimacs_max_flow_internal(Graph& g,
const int NODE_FIELDS = 2; /* no of fields in node line */
const int P_FIELDS = 3; /* no of fields in problem line */
typedef typename graph_traits<Graph>::vertices_size_type vertices_size_type;
typedef typename graph_traits<Graph>::vertex_descriptor vertex_descriptor;
typedef typename graph_traits<Graph>::edge_descriptor edge_descriptor;

View File

@ -76,7 +76,6 @@ namespace boost {
template < typename Vertex, typename Graph >
void finish_vertex(Vertex u, const Graph & g)
{
typedef typename boost::property_traits<ParityMap>::value_type parity_type;
typedef typename boost::property_traits<InternalParityMap>::value_type internal_parity_type;
++m_visited;
@ -131,10 +130,7 @@ namespace boost {
typename boost::property_traits<WeightMap>::value_type
stoer_wagner_min_cut(const UndirectedGraph& g, WeightMap weights, ParityMap parities, VertexAssignmentMap assignments, KeyedUpdatablePriorityQueue& pq, IndexMap index_map) {
typedef typename boost::graph_traits<UndirectedGraph>::vertex_descriptor vertex_descriptor;
typedef typename boost::graph_traits<UndirectedGraph>::vertices_size_type vertices_size_type;
typedef typename boost::graph_traits<UndirectedGraph>::edge_descriptor edge_descriptor;
typedef typename boost::property_traits<WeightMap>::value_type weight_type;
typedef typename boost::property_traits<ParityMap>::value_type parity_type;
typename graph_traits<UndirectedGraph>::vertex_iterator u_iter, u_end;
@ -185,9 +181,9 @@ namespace boost {
typedef typename boost::graph_traits<UndirectedGraph>::edge_descriptor edge_descriptor;
BOOST_CONCEPT_ASSERT((boost::Convertible<typename boost::graph_traits<UndirectedGraph>::directed_category, boost::undirected_tag>));
BOOST_CONCEPT_ASSERT((boost::ReadablePropertyMapConcept<WeightMap, edge_descriptor>));
typedef typename boost::property_traits<WeightMap>::value_type weight_type;
// typedef typename boost::property_traits<WeightMap>::value_type weight_type;
BOOST_CONCEPT_ASSERT((boost::WritablePropertyMapConcept<ParityMap, vertex_descriptor>));
typedef typename boost::property_traits<ParityMap>::value_type parity_type;
// typedef typename boost::property_traits<ParityMap>::value_type parity_type;
BOOST_CONCEPT_ASSERT((boost::ReadWritePropertyMapConcept<VertexAssignmentMap, vertex_descriptor>));
BOOST_CONCEPT_ASSERT((boost::Convertible<vertex_descriptor, typename boost::property_traits<VertexAssignmentMap>::value_type>));
BOOST_CONCEPT_ASSERT((boost::KeyedUpdatableQueueConcept<KeyedUpdatablePriorityQueue>));

View File

@ -212,7 +212,6 @@ namespace detail
{
BOOST_CONCEPT_ASSERT(( IncidenceGraphConcept<Graph> ));
typedef typename graph_traits<Graph>::vertex_descriptor Vertex;
typedef typename graph_traits<Graph>::edge_descriptor Edge;
typedef typename graph_traits<Graph>::out_edge_iterator OutIterator;
// get the current vertex

View File

@ -71,7 +71,6 @@ namespace boost
if (num_vertices(g) == 0)
return;
typedef typename graph_traits < Graph >::vertex_descriptor vertex;
typedef typename graph_traits < Graph >::edge_descriptor edge;
typedef typename graph_traits < Graph >::vertex_iterator vertex_iterator;
typedef typename property_traits < VertexIndexMap >::value_type size_type;
typedef typename graph_traits <
@ -208,7 +207,6 @@ namespace boost
// Add vertices to the transitive closure graph
typedef typename graph_traits < GraphTC >::vertex_descriptor tc_vertex;
{
vertex_iterator i, i_end;
for (boost::tie(i, i_end) = vertices(g); i != i_end; ++i)
@ -306,7 +304,6 @@ namespace boost
template < typename G > void warshall_transitive_closure(G & g)
{
typedef typename graph_traits < G >::vertex_descriptor vertex;
typedef typename graph_traits < G >::vertex_iterator vertex_iterator;
BOOST_CONCEPT_ASSERT(( AdjacencyMatrixConcept < G > ));
@ -332,7 +329,6 @@ namespace boost
template < typename G > void warren_transitive_closure(G & g)
{
using namespace boost;
typedef typename graph_traits < G >::vertex_descriptor vertex;
typedef typename graph_traits < G >::vertex_iterator vertex_iterator;
BOOST_CONCEPT_ASSERT(( AdjacencyMatrixConcept < G > ));

View File

@ -591,17 +591,11 @@ two_graphs_common_spanning_trees
typedef typename GraphTraits::edges_size_type edges_size_type;
typedef typename GraphTraits::edge_iterator edge_iterator;
typedef typename Seq::const_iterator seq_const_iterator;
typedef typename Seq::difference_type seq_diff_type;
typedef typename Seq::value_type seq_value_type;
typedef typename Seq::size_type seq_size_type;
typedef typename Seq::iterator seq_iterator;
typedef typename Order::const_iterator order_const_iterator;
typedef typename Order::difference_type order_diff_type;
typedef typename Order::value_type order_value_type;
typedef typename Order::size_type order_size_type;
typedef typename Order::iterator order_iterator;
BOOST_STATIC_ASSERT((is_same<order_value_type, edge_descriptor>::value));
BOOST_CONCEPT_ASSERT((Convertible<order_size_type, edges_size_type>));
@ -846,7 +840,6 @@ two_graphs_common_spanning_trees
typedef graph_traits<Graph> GraphTraits;
typedef typename GraphTraits::edge_descriptor edge_descriptor;
typedef typename GraphTraits::edges_size_type edges_size_type;
typedef typename GraphTraits::edge_iterator edge_iterator;
std::vector<edge_descriptor> iGO, vGO;

View File

@ -1014,8 +1014,6 @@ namespace boost {
bool vf2_subgraph_iso(const GraphSmall& graph_small, const GraphLarge& graph_large,
SubGraphIsoMapCallback user_callback) {
typedef typename graph_traits<GraphSmall>::vertex_descriptor vertex_small_type;
return vf2_subgraph_iso(graph_small, graph_large, user_callback,
get(vertex_index, graph_small), get(vertex_index, graph_large),
vertex_order_by_mult(graph_small),
@ -1144,8 +1142,6 @@ namespace boost {
bool vf2_graph_iso(const Graph1& graph1, const Graph2& graph2,
GraphIsoMapCallback user_callback) {
typedef typename graph_traits<Graph1>::vertex_descriptor vertex1_type;
return vf2_graph_iso(graph1, graph2, user_callback,
get(vertex_index, graph1), get(vertex_index, graph2),
vertex_order_by_mult(graph1),

View File

@ -51,10 +51,6 @@ void write_dimacs_max_flow(const Graph& g,
typename graph_traits<Graph>::vertex_descriptor sink,
std::ostream& out)
{
typedef typename graph_traits<Graph>::vertex_descriptor vertex_descriptor;
typedef typename graph_traits<Graph>::vertices_size_type vertices_size_type;
typedef typename graph_traits<Graph>::edge_descriptor edge_descriptor;
typedef typename graph_traits<Graph>::edges_size_type edges_size_type;
typedef typename graph_traits<Graph>::edge_iterator edge_iterator;
out << "c DIMACS max-flow file generated from boost::write_dimacs_max_flow" << std::endl;

View File

@ -17,7 +17,6 @@ template <typename Graph>
void test_graph_nonloop()
{
typedef typename graph_traits<Graph>::vertex_descriptor Vertex;
typedef typename graph_traits<Graph>::edge_descriptor Edge;
// Build a graph with 1 edge and turn it into a loop.
Graph g(5);
@ -36,7 +35,6 @@ template <typename Graph>
void test_multigraph_nonloop()
{
typedef typename graph_traits<Graph>::vertex_descriptor Vertex;
typedef typename graph_traits<Graph>::edge_descriptor Edge;
// Build a graph with 1 edge and turn it into a loop.
Graph g(5);
@ -55,7 +53,6 @@ template <typename Graph>
void test_graph_loop()
{
typedef typename graph_traits<Graph>::vertex_descriptor Vertex;
typedef typename graph_traits<Graph>::edge_descriptor Edge;
Graph g(5);
Vertex v = *next(vertices(g).first, 2);
@ -70,7 +67,6 @@ template <typename Graph>
void test_multigraph_loop()
{
typedef typename graph_traits<Graph>::vertex_descriptor Vertex;
typedef typename graph_traits<Graph>::edge_descriptor Edge;
Graph g(5);
Vertex v = *next(vertices(g).first, 2);

View File

@ -122,9 +122,7 @@ int test_graph(const std::string& dimacs_filename)
typedef graph_traits<graph>::edge_iterator edge_iterator_t;
typedef graph_traits<graph>::vertex_iterator vertex_iterator_t;
typedef graph_traits<graph>::edges_size_type e_size_t;
typedef graph_traits<graph>::vertices_size_type v_size_t;
typedef graph_traits<graph>::vertex_descriptor vertex_t;
typedef std::pair<vertex_t, vertex_t> vertex_pair_t;
typedef edge_index_update_visitor<property_map<graph, edge_index_t>::type>
edge_visitor_t;

View File

@ -122,7 +122,6 @@ int main(int, char **)
typedef property_map<mygraph_t, edge_weight_t>::type WeightMap;
typedef mygraph_t::vertex_descriptor vertex;
typedef mygraph_t::edge_descriptor edge_descriptor;
typedef mygraph_t::vertex_iterator vertex_iterator;
typedef std::pair<int, int> edge;
// specify data

View File

@ -31,8 +31,6 @@ template <typename Graph>
void build_graph(Graph& g,
typename vertex_vector<Graph>::type& v)
{
typedef typename graph_traits<Graph>::vertex_descriptor Vertex;
// add vertices
for(size_t i = 0; i < N; ++i) {
v[i] = add_vertex(g);

View File

@ -27,8 +27,6 @@ struct vertex_vector
template <typename Graph>
void build_graph(Graph& g, typename vertex_vector<Graph>::type& v)
{
typedef typename graph_traits<Graph>::vertex_descriptor Vertex;
// add vertices
for(size_t i = 0; i < N; ++i) {
v[i] = add_vertex(g);
@ -98,7 +96,7 @@ int
main(int, char *[])
{
typedef undirected_graph<> Graph;
typedef directed_graph<> Digraph;
// typedef directed_graph<> Digraph;
// TODO: write a test for directed clustering coefficient.

View File

@ -331,7 +331,6 @@ int test_main(int argc, char* argv[])
{
GraphMInt gm(10);
typedef graph_traits<GraphMInt>::vertex_iterator VertexItM;
typedef graph_traits<GraphMInt>::edge_descriptor EdgeM;
VertexItM vi1, vi2, vi_end;
for (boost::tie(vi1, vi_end) = vertices(gm); vi1 != vi_end; ++vi1)
{

View File

@ -22,8 +22,6 @@ template <typename Graph>
void build_graph(Graph& g,
vector<typename graph_traits<Graph>::vertex_descriptor>& v)
{
typedef typename graph_traits<Graph>::vertex_descriptor Vertex;
// add vertices
for(size_t i = 0; i < N; ++i) {
v[i] = add_vertex(g);

View File

@ -94,9 +94,6 @@ int test_main(int argc, char* argv[])
property<vertex_index_t, int >,
property<edge_weight_t, double> > graph_t;
typedef graph_traits<graph_t>::vertex_descriptor vertex_t;
typedef graph_traits<graph_t>::edge_descriptor edge_t;
graph_t graph;
generate_random_graph(graph, vertices_to_create, edges_to_create, generator);

View File

@ -31,8 +31,6 @@ template <typename Graph>
void build_graph(Graph& g,
typename vertex_vector<Graph>::type& v)
{
typedef typename graph_traits<Graph>::vertex_descriptor Vertex;
// add vertices
for(size_t i = 0; i < N; ++i) {
v[i] = add_vertex(g);

View File

@ -75,9 +75,6 @@ bool test_graph(std::istream& dotfile, graph_t& graph,
MassMap mass,
WeightMap weight) {
typedef typename graph_traits < graph_t >::edge_descriptor edge_t;
typedef typename graph_traits < graph_t >::vertex_descriptor vertex_t;
// Construct a graph and set up the dynamic_property_maps.
dynamic_properties dp(ignore_other_properties);
dp.property(node_id,name);

View File

@ -64,7 +64,6 @@ void test()
template <typename Graph>
void build()
{
typedef typename graph_traits<Graph>::vertex_descriptor Vertex;
typedef typename graph_traits<Graph>::vertex_iterator Iterator;
typedef typename property_map<Graph, vertex_index_t>::type IndexMap;

View File

@ -78,10 +78,8 @@ template<typename Graph>
void
test_circle_layout(Graph*, typename graph_traits<Graph>::vertices_size_type n)
{
typedef typename graph_traits<Graph>::vertex_descriptor vertex;
typedef typename graph_traits<Graph>::vertex_iterator vertex_iterator;
typedef typename graph_traits<Graph>::vertices_size_type vertices_size_type;
typedef typename graph_traits<Graph>::edges_size_type edges_size_type;
Graph g(n);

View File

@ -131,7 +131,6 @@ void matching_test(std::size_t num_v, const std::string& graph_name)
typedef vector_property_map< typename graph_traits<Graph>::vertex_descriptor, vertex_index_map_t > mate_t;
typedef typename graph_traits<Graph>::vertex_iterator vertex_iterator_t;
typedef typename graph_traits<Graph>::vertex_descriptor vertex_descriptor_t;
typedef typename graph_traits<Graph>::vertices_size_type v_size_t;
const std::size_t double_num_v = num_v * 2;

View File

@ -195,10 +195,6 @@ struct simple_callback {
typedef typename boost::graph_traits<Graph>::vertex_descriptor Vertex;
typedef typename boost::property_map<Graph, boost::vertex_index_t>::type VertexIndexMap;
typedef typename boost::property_map<Graph, boost::vertex_name_t>::type VertexNameMap;
typedef typename boost::property_map<Graph, boost::edge_name_t>::type EdgeNameMap;
std::stringstream subgraph_string;
BGL_FORALL_VERTICES_T(vertex1, m_graph1, Graph) {
@ -308,9 +304,6 @@ int test_main (int argc, char *argv[]) {
boost::property<boost::vertex_index_t, unsigned int> >,
boost::property<boost::edge_name_t, unsigned int> > Graph;
typedef boost::graph_traits<Graph>::vertex_descriptor Vertex;
typedef boost::graph_traits<Graph>::edge_descriptor Edge;
typedef boost::property_map<Graph, boost::vertex_name_t>::type VertexNameMap;
typedef boost::property_map<Graph, boost::edge_name_t>::type EdgeNameMap;

View File

@ -31,8 +31,6 @@ struct vertex_vector
template <typename Graph>
void build_graph(Graph& g, typename vertex_vector<Graph>::type& v)
{
typedef typename graph_traits<Graph>::vertex_descriptor Vertex;
// add vertices
for(size_t i = 0; i < N; ++i) {
v[i] = add_vertex(g);

View File

@ -86,7 +86,6 @@ void testScalability(unsigned numpts)
property <edge_weight_t, double,
property<edge_index_t, int> > > Graph;
typedef graph_traits<Graph>::vertex_descriptor Vertex;
typedef graph_traits <Graph>::edge_descriptor Edge;
typedef property_map<Graph, edge_weight_t>::type WeightMap;
typedef set<simple_point<double>, cmpPnt<double> > PointSet;
typedef vector< Vertex > Container;
@ -199,7 +198,6 @@ int main(int argc, char* argv[])
typedef adjacency_matrix<undirectedS, no_property,
property <edge_weight_t, double> > Graph;
typedef graph_traits<Graph>::vertex_descriptor Vertex;
typedef graph_traits <Graph>::edge_descriptor Edge;
typedef vector<Vertex> Container;
typedef property_map<Graph, edge_weight_t>::type WeightMap;
typedef property_map<Graph, vertex_index_t>::type VertexMap;

View File

@ -195,9 +195,7 @@ int test_graph(const std::string& dimacs_filename)
typedef graph_traits<graph>::edge_iterator edge_iterator_t;
typedef graph_traits<graph>::vertex_iterator vertex_iterator_t;
typedef graph_traits<graph>::edges_size_type e_size_t;
typedef graph_traits<graph>::vertices_size_type v_size_t;
typedef graph_traits<graph>::vertex_descriptor vertex_t;
typedef std::pair<vertex_t, vertex_t> vertex_pair_t;
typedef edge_index_update_visitor<property_map<graph, edge_index_t>::type>
edge_visitor_t;

View File

@ -109,19 +109,9 @@ int main(int, char* [])
++E;
}
typedef boost::graph_property_iter_range< Graph, vertex_id_t>::const_iterator TNodeConstIterator;
typedef boost::graph_property_iter_range< Graph, vertex_id_t>::const_type TNodeConstIteratorType;
typedef boost::graph_property_iter_range< Graph, vertex_id_t>::iterator TNodeIterator;
typedef boost::graph_property_iter_range< Graph, vertex_id_t>::type TNodeIteratorType;
typedef boost::graph_property_iter_range< Graph, edge_id_t>::const_iterator TLinkConstIterator;
typedef boost::graph_property_iter_range< Graph, edge_id_t>::const_type TLinkConstIteratorType;
typedef boost::graph_property_iter_range< Graph, edge_id_t>::iterator TLinkIterator;
typedef boost::graph_property_iter_range< Graph, edge_id_t>::type TLinkIteratorType;
typedef std::pair<TLinkConstIterator, TLinkConstIterator> tLinkConstIteratorPair;
TLinkIterator itEdgeBegin, itEdgeEnd;

View File

@ -16,7 +16,6 @@ using namespace boost;
int test_main(int, char*[])
{
typedef adjacency_list<listS, vecS, undirectedS> Graph;
typedef graph_traits<Graph>::vertex_descriptor vertex_descriptor;
typedef graph_traits<Graph>::vertices_size_type vertices_size_type;
typedef property_map<Graph, vertex_index_t>::const_type vertex_index_map;

View File

@ -45,9 +45,6 @@ struct edge_t
// the example from Stoer & Wagner (1997)
BOOST_AUTO_TEST_CASE(test0)
{
typedef boost::graph_traits<undirected_graph>::vertex_descriptor vertex_descriptor;
typedef boost::graph_traits<undirected_graph>::edge_descriptor edge_descriptor;
edge_t edges[] = {{0, 1}, {1, 2}, {2, 3},
{0, 4}, {1, 4}, {1, 5}, {2, 6}, {3, 6}, {3, 7}, {4, 5}, {5, 6}, {6, 7}};
weight_type ws[] = {2, 3, 4, 3, 2, 2, 2, 2, 2, 3, 1, 3};
@ -72,16 +69,12 @@ BOOST_AUTO_TEST_CASE(test0)
BOOST_AUTO_TEST_CASE(test1)
{
{ // if only one vertex, can't run `boost::stoer_wagner_min_cut`
typedef boost::graph_traits<undirected_graph>::vertex_descriptor vertex_descriptor;
typedef boost::graph_traits<undirected_graph>::edge_descriptor edge_descriptor;
undirected_graph g;
add_vertex(g);
BOOST_CHECK_THROW(boost::stoer_wagner_min_cut(g, get(boost::edge_weight, g)), boost::bad_graph);
}{ // three vertices with one multi-edge
typedef boost::graph_traits<undirected_graph>::vertex_descriptor vertex_descriptor;
typedef boost::graph_traits<undirected_graph>::edge_descriptor edge_descriptor;
edge_t edges[] = {{0, 1}, {1, 2}, {1, 2}, {2, 0}};
weight_type ws[] = {3, 1, 1, 1};
@ -104,9 +97,6 @@ BOOST_AUTO_TEST_CASE(test1)
// example by Daniel Trebbien
BOOST_AUTO_TEST_CASE(test2)
{
typedef boost::graph_traits<undirected_graph>::vertex_descriptor vertex_descriptor;
typedef boost::graph_traits<undirected_graph>::edge_descriptor edge_descriptor;
edge_t edges[] = {{5, 2}, {0, 6}, {5, 6},
{3, 1}, {0, 1}, {6, 3}, {4, 6}, {2, 4}, {5, 3}};
weight_type ws[] = {1, 3, 4, 6, 4, 1, 2, 5, 2};
@ -129,9 +119,6 @@ BOOST_AUTO_TEST_CASE(test2)
// example by Daniel Trebbien
BOOST_AUTO_TEST_CASE(test3)
{
typedef boost::graph_traits<undirected_graph>::vertex_descriptor vertex_descriptor;
typedef boost::graph_traits<undirected_graph>::edge_descriptor edge_descriptor;
edge_t edges[] = {{3, 4}, {3, 6}, {3, 5}, {0, 4}, {0, 1}, {0, 6}, {0, 7},
{0, 5}, {0, 2}, {4, 1}, {1, 6}, {1, 5}, {6, 7}, {7, 5}, {5, 2}, {3, 4}};
weight_type ws[] = {0, 3, 1, 3, 1, 2, 6, 1, 8, 1, 1, 80, 2, 1, 1, 4};
@ -196,7 +183,6 @@ BOOST_AUTO_TEST_CASE(test4)
BOOST_AUTO_TEST_CASE(test_prgen_20_70_2)
{
typedef boost::graph_traits<undirected_graph>::vertex_descriptor vertex_descriptor;
typedef boost::graph_traits<undirected_graph>::edge_descriptor edge_descriptor;
std::ifstream ifs((test_dir + "/prgen_input_graphs/prgen_20_70_2.net").c_str());
undirected_graph g;
@ -221,7 +207,6 @@ BOOST_AUTO_TEST_CASE(test_prgen_20_70_2)
BOOST_AUTO_TEST_CASE(test_prgen_50_40_2)
{
typedef boost::graph_traits<undirected_graph>::vertex_descriptor vertex_descriptor;
typedef boost::graph_traits<undirected_graph>::edge_descriptor edge_descriptor;
std::ifstream ifs((test_dir + "/prgen_input_graphs/prgen_50_40_2.net").c_str());
undirected_graph g;
@ -239,7 +224,6 @@ BOOST_AUTO_TEST_CASE(test_prgen_50_40_2)
BOOST_AUTO_TEST_CASE(test_prgen_50_70_2)
{
typedef boost::graph_traits<undirected_graph>::vertex_descriptor vertex_descriptor;
typedef boost::graph_traits<undirected_graph>::edge_descriptor edge_descriptor;
std::ifstream ifs((test_dir + "/prgen_input_graphs/prgen_50_70_2.net").c_str());
undirected_graph g;

View File

@ -27,7 +27,6 @@ int test_main(int, char*[])
> graph_t;
typedef subgraph<graph_t> subgraph_t;
typedef graph_traits<subgraph_t>::vertex_descriptor vertex_t;
typedef graph_traits<subgraph_t>::edge_descriptor edge_t;
mt19937 gen;
for (int t = 0; t < 100; t += 5) {

View File

@ -17,9 +17,6 @@ void test_graph_bundle(Graph& g, boost::mpl::true_) {
using namespace boost;
std::cout << "...test_graph_bundle\n";
typedef typename graph_property_type<Graph>::type Property;
typedef typename graph_bundle_type<Graph>::type Bundle;
GraphBundle& b1 = g[graph_bundle];
GraphBundle& b2 = get_property(g);
ignore(b1); ignore(b2);

View File

@ -27,8 +27,6 @@ struct cycle_validator
void cycle(const Path& p, const Graph& g)
{
++cycles;
typedef typename graph_traits<Graph>::vertex_descriptor Vertex;
typedef typename graph_traits<Graph>::edge_descriptor Edge;
// Check to make sure that each of the vertices in the path
// is truly connected and that the back is connected to the
// front - it's not validating that we find all paths, just