First big patch to fix -Wunused-local-typedefs

-Wunused-local-typedefs is a new warning flag of gcc-4.7, and it will enabled
 by -Wall since gcc-4.8 (not yet released).

The fix is a big set of removals of unused typedefs (or comments, or moves,
depending on the context).
This commit is contained in:
Laurent Rineau 2012-08-01 13:29:16 +00:00
parent 98992ea06b
commit db194534c7
91 changed files with 21 additions and 282 deletions

View File

@ -482,13 +482,13 @@ class Algebraic_structure_traits_base< Type_, Field_tag >
: public std::binary_function< Type, Type, bool > {
public:
bool operator()( const Type& CGAL_precondition_code(x), const Type& /* y */) const {
typedef Algebraic_structure_traits<Type> AST;
CGAL_precondition_code( typedef Algebraic_structure_traits<Type> AST);
CGAL_precondition( typename AST::Is_zero()(x) == false );
return true;
}
// second operator computing q
bool operator()( const Type& x, const Type& y, Type& q) const {
typedef Algebraic_structure_traits<Type> AST;
CGAL_precondition_code(typedef Algebraic_structure_traits<Type> AST);
CGAL_precondition( typename AST::Is_zero()(x) == false );
q = y/x;
return true;

View File

@ -264,7 +264,6 @@ public:
private:
void intern_decompose( Polynomial P_, ::CGAL::Tag_true){
typename FT_poly::Decompose decompose;
typedef typename FT_poly::Numerator_type Numerator_poly;
typename FT_poly::Numerator_type NumP;
typename FT_poly::Denominator_type dummy;

View File

@ -174,7 +174,6 @@ namespace CGAL {
Sign sign_at( const typename AK::Polynomial_1_2 & equation,
const typename AK::Root_for_circles_2_2 & r)
{
typedef typename AK::Root_of_2 Root_of_2;
Comparison_result c = compare(r.x()*equation.a(),
-equation.c() - r.y()*equation.b());
if(c == EQUAL) return ZERO;

View File

@ -158,7 +158,6 @@ namespace CGAL {
Sign sign_at( const typename AK::Polynomial_for_circles_2_2 & equation,
const typename AK::Root_for_circles_2_2 & r)
{
typedef typename AK::Root_of_2 Root_of_2;
Comparison_result c = compare(square(r.x() - equation.a()),
equation.r_sq() -
square(r.y() - equation.b()));
@ -186,7 +185,6 @@ namespace CGAL {
x_critical_points(const typename AK::Polynomial_for_circles_2_2 & c,
OutputIterator res)
{
typedef typename AK::Root_of_2 Root_of_2;
typedef typename AK::FT FT;
typedef typename AK::Root_for_circles_2_2 Root_for_circles_2_2;
@ -216,8 +214,6 @@ namespace CGAL {
y_critical_points(const typename AK::Polynomial_for_circles_2_2 & c,
OutputIterator res)
{
typedef typename AK::Root_of_2 Root_of_2;
typedef typename AK::FT FT;
typedef typename AK::Root_for_circles_2_2 Root_for_circles_2_2;
*res++ = Root_for_circles_2_2(c.a(),

View File

@ -244,7 +244,7 @@ primal(const Edge e) const
{
typedef typename Geom_traits::Segment_2 Segment;
typedef typename Geom_traits::Ray_2 Ray;
typedef CGAL::Hyperbola_segment_2<Gt> Hyperbola_segment;
// typedef CGAL::Hyperbola_segment_2<Gt> Hyperbola_segment;
typedef CGAL::Parabola_segment_2<Gt> Parabola_segment;
// typedef typename Geom_traits::Hyperbola_segment_2 Hyperbola_segment;
// typedef typename Geom_traits::Parabola_segment_2 Parabola_segment;

View File

@ -214,7 +214,6 @@ void insert (Arrangement_on_surface_2<GeomTraits, TopTraits>& arr,
const Curve& c, const PointLocation& pl,
typename PointLocation::Point_2*)
{
typedef Arrangement_on_surface_2<GeomTraits, TopTraits> Arr;
typedef typename TopTraits::Zone_insertion_visitor Zone_visitor;
Zone_visitor visitor;
@ -1184,7 +1183,6 @@ bool is_valid (const Arrangement_on_surface_2<GeomTraits, TopTraits>& arr)
typedef Arrangement_on_surface_2<GeomTraits, TopTraits> Arr;
typedef GeomTraits Geometry_traits_2;
typedef typename Geometry_traits_2::Point_2 Point_2;
typedef typename Geometry_traits_2::X_monotone_curve_2 X_monotone_curve_2;
// Define the sweep-line types:
@ -1200,8 +1198,6 @@ bool is_valid (const Arrangement_on_surface_2<GeomTraits, TopTraits>& arr)
typedef typename Arr::Vertex_const_handle Vertex_const_handle;
typedef typename Arr::Isolated_vertex_const_iterator
Isolated_vertex_const_iterator;
typedef typename Arr::Ccb_halfedge_const_circulator
Ccb_halfedge_const_circulator;
typedef typename Arr::Halfedge_around_vertex_const_circulator
Halfedge_around_vertex_const_circulator;
@ -1454,9 +1450,6 @@ OutputIterator zone (Arrangement_on_surface_2<GeomTraits, TopTraits>& arr,
const typename GeomTraits::X_monotone_curve_2& c,
OutputIterator oi)
{
typedef Arrangement_on_surface_2<GeomTraits, TopTraits>
Arrangement_on_surface_2;
// Create a default point-location object and use it to insert the curve.
typename TopTraits::Default_point_location_strategy def_pl (arr);
@ -1585,9 +1578,6 @@ template <class GeomTraits, class TopTraits, class Curve>
bool do_intersect (Arrangement_on_surface_2<GeomTraits, TopTraits>& arr,
const Curve& c)
{
typedef Arrangement_on_surface_2<GeomTraits, TopTraits>
Arrangement_on_surface_2;
// Create a default point-location object and use it to insert the curve.
typename TopTraits::Default_point_location_strategy def_pl (arr);

View File

@ -132,9 +132,6 @@ void prepare_for_sweep (Arrangement& arr,
PointOutIter iso_points,
const ExTraits * /* ex_tr */)
{
typedef typename Arrangement::X_monotone_curve_2 X_monotone_curve_2;
typedef typename Arrangement::Point_2 Point_2;
typedef typename Arrangement::Vertex_iterator Vertex_iterator;
typedef typename Arrangement::Edge_iterator Edge_iterator;
typedef typename Arrangement::Vertex_handle Vertex_handle;

View File

@ -154,7 +154,6 @@ public:
std::istream &
operator>>(std::istream & is, Circular_arc_point_2<CK> &p)
{
typedef typename CK::Root_of_2 Root_of_2;
typedef typename CK::Root_for_circles_2_2 Root_for_circles_2_2;
Root_for_circles_2_2 r;

View File

@ -68,8 +68,6 @@ namespace CircularFunctors {
typename CK::Polynomial_for_circles_2_2
get_equation( const typename CK::Circle_2 & c )
{
typedef typename CK::RT RT;
typedef typename CK::Algebraic_kernel AK;
return AK().construct_polynomial_for_circles_2_2_object()

View File

@ -227,11 +227,11 @@ namespace CircularFunctors {
//CGAL_kernel_precondition (A1.is_x_monotone());
//CGAL_kernel_precondition (A2.is_x_monotone());
#ifdef CGAL_INTERSECTION_MAP_FOR_XMONOTONIC_ARC_WITH_SAME_SUPPORTING_CIRCLE
// intersection found on the map
typedef std::vector<CGAL::Object> solutions_container;
typedef typename CK::Circular_arc_2 Circular_arc_2;
#ifdef CGAL_INTERSECTION_MAP_FOR_XMONOTONIC_ARC_WITH_SAME_SUPPORTING_CIRCLE
// intersection found on the map
solutions_container early_sols;
if(Circular_arc_2::template find_intersection< solutions_container >
(A1,A2,early_sols)) {
@ -1057,9 +1057,6 @@ template < class CK, class OutputIterator >
OutputIterator res )
{
typedef typename CK::Circular_arc_2 Circular_arc_2;
typedef typename CK::Circle_2 Circle_2;
typedef typename CK::FT FT;
typedef typename CK::Point_2 Point_2;
typedef typename CK::Circular_arc_point_2 Circular_arc_point_2;
typedef typename CK::Root_for_circles_2_2 Root_for_circles_2_2;
@ -1320,9 +1317,6 @@ template < class CK, class OutputIterator >
OutputIterator res )
{
typedef typename CK::Circular_arc_2 Circular_arc_2;
typedef typename CK::Circle_2 Circle_2;
typedef typename CK::FT FT;
typedef typename CK::Point_2 Point_2;
typedef std::pair<CGAL::Object,bool > S_pair;
@ -1541,8 +1535,6 @@ advanced_make_xy_monotone( const typename CK::Circular_arc_2 &a,
CGAL::Bbox_2 circular_arc_bbox
( const typename CK::Kernel_base::Circular_arc_2 & a)
{
typedef typename CK::Root_of_2 Root_of_2;
typedef typename CK::FT FT;
typedef CGAL::Interval_nt<false>::Protector IntervalProtector;
typedef CGAL::Interval_nt<false> Interval;

View File

@ -33,8 +33,6 @@ namespace LinearFunctors {
typename CK::Polynomial_1_2
get_equation( const typename CK::Line_2 & L )
{
typedef typename CK::RT RT;
return typename CK::Polynomial_1_2(L.a(),L.b(),L.c());
}

View File

@ -157,7 +157,6 @@ namespace CircularFunctors {
if(A2.supporting_line().is_vertical())
return CGAL::SMALLER;
typedef typename CK::Circular_arc_point_2 Circular_arc_point_2;
typedef typename CK::Polynomial_1_2 Polynomial_1_2;
typedef typename CK::Root_of_2 Root_of_2;
@ -418,8 +417,7 @@ namespace CircularFunctors {
typedef typename CK::Circular_arc_point_2 Circular_arc_point_2;
typedef typename CK::Line_arc_2 Line_arc_2;
typedef typename CK::Point_2 Point_2;
typedef typename CK::Root_of_2 Root_of_2;
typedef typename CK::Root_for_circles_2_2 Root_for_circles_2_2;
// typedef typename CK::Root_for_circles_2_2 Root_for_circles_2_2;
#ifdef CGAL_CK_EXPLOIT_IDENTITY
bool a1s_a2s = a1.source().equal_ref(a2.source());
@ -757,8 +755,6 @@ namespace CircularFunctors {
typedef typename CK::Line_arc_2 Line_arc_2;
typedef typename CK::Point_2 Point_2;
typedef typename CK::Line_2 Line_2;
typedef typename CK::Root_of_2 Root_of_2;
typedef typename CK::Root_for_circles_2_2 Root_for_circles_2_2;
if(LinearFunctors::non_oriented_equal<CK>(l, la.supporting_line())) {
*res++ = make_object(la);
@ -784,7 +780,6 @@ namespace CircularFunctors {
{
typedef typename CK::Circular_arc_2 Circular_arc_2;
typedef typename CK::Circular_arc_point_2 Circular_arc_point_2;
typedef typename CK::Line_2 Line_2;
typedef std::vector<CGAL::Object > solutions_container;
solutions_container solutions;

View File

@ -617,7 +617,6 @@ std::ostream& operator << ( std::ostream& os, const ConicHPA2<_PT,_DA>& c)
template< class _PT, class _DA>
std::istream& operator >> ( std::istream& is, ConicHPA2<_PT,_DA>& c)
{
typedef ConicHPA2<_PT,_DA> Conic;
typedef typename _DA::RT RT;
RT r, s, t, u, v, w;

View File

@ -37,17 +37,13 @@ template<typename Nef_polyhedron>
void convex_decomposition_3(Nef_polyhedron& N)
{
typedef typename Nef_polyhedron::SNC_structure SNC_structure;
typedef typename SNC_structure::Vertex_handle Vertex_handle;
typedef typename SNC_structure::Halfedge_handle Halfedge_handle;
typedef typename SNC_structure::SHalfedge_handle SHalfedge_handle;
typedef typename SNC_structure::SHalfedge_iterator SHalfedge_iterator;
typedef typename Nef_polyhedron::Point_3 Point_3;
typedef typename Nef_polyhedron::Vector_3 Vector_3;
typedef typename Nef_polyhedron::Sphere_point Sphere_point;
typedef typename Nef_polyhedron::FT FT;
typedef typename CGAL::Single_wall_creator<Nef_polyhedron> Single_wall;
typedef typename CGAL::Single_wall_creator2<Nef_polyhedron> Single_wall2;
typedef typename CGAL::YVertical_wall_builder<Nef_polyhedron> YVertical_wall_builder;
typedef typename CGAL::Reflex_vertex_searcher<Nef_polyhedron> Reflex_vertex_searcher;
typedef typename CGAL::Ray_hit_generator2<Nef_polyhedron> Ray_hit2;

View File

@ -41,7 +41,6 @@ ch_graham_andrew_scan( BidirectionalIterator first,
OutputIterator result,
const Traits& ch_traits)
{
typedef typename Traits::Less_xy_2 Less_xy;
typedef typename Traits::Point_2 Point_2;
typedef typename Traits::Left_turn_2 Left_turn;
@ -129,8 +128,6 @@ ch__ref_graham_andrew_scan( BidirectionalIterator first,
OutputIterator& result,
const Traits& ch_traits)
{
typedef typename Traits::Less_xy_2 Less_xy;
typedef typename Traits::Point_2 Point_2;
typedef typename Traits::Left_turn_2 Left_turn;
CGAL_ch_precondition_code(
@ -202,9 +199,7 @@ ch_graham_andrew( InputIterator first,
OutputIterator result,
const Traits& ch_traits)
{
typedef typename Traits::Less_xy_2 Less_xy;
typedef typename Traits::Point_2 Point_2;
typedef typename Traits::Left_turn_2 Left_turn;
typedef typename Traits::Equal_2 Equal_2;
Equal_2 equal_points = ch_traits.equal_2_object();
@ -250,9 +245,7 @@ ch_lower_hull_scan( InputIterator first,
OutputIterator result,
const Traits& ch_traits)
{
typedef typename Traits::Less_xy_2 Less_xy;
typedef typename Traits::Point_2 Point_2;
typedef typename Traits::Left_turn_2 Left_turn;
typedef typename Traits::Equal_2 Equal_2;
Equal_2 equal_points = ch_traits.equal_2_object();
@ -287,9 +280,7 @@ ch_upper_hull_scan( InputIterator first,
OutputIterator result,
const Traits& ch_traits)
{
typedef typename Traits::Less_xy_2 Less_xy;
typedef typename Traits::Point_2 Point_2;
typedef typename Traits::Left_turn_2 Left_turn;
typedef typename Traits::Equal_2 Equal_2;
Equal_2 equal_points = ch_traits.equal_2_object();

View File

@ -90,7 +90,6 @@ is_cw_strongly_convex_2( ForwardIterator first, ForwardIterator last,
const Traits& ch_traits)
{
typedef typename Traits::Less_xy_2 Less_xy;
typedef typename Traits::Left_turn_2 Left_turn;
typedef typename Traits::Equal_2 Equal_2;
Less_xy smaller_xy = ch_traits.less_xy_2_object();

View File

@ -475,7 +475,6 @@ ch_quickhull_3_scan(TDS_2& tds,
const Traits& traits)
{
typedef typename TDS_2::Edge Edge;
typedef typename TDS_2::Face_circulator Face_circulator;
typedef typename TDS_2::Face_handle Face_handle;
typedef typename TDS_2::Vertex_handle Vertex_handle;
typedef typename Traits::Point_3 Point_3;
@ -562,9 +561,7 @@ void non_coplanar_quickhull_3(std::list<typename Traits::Point_3>& points,
TDS_2& tds, const Traits& traits)
{
typedef typename Traits::Point_3 Point_3;
typedef typename Traits::Plane_3 Plane_3;
typedef typename TDS_2::Vertex_handle Vertex_handle;
typedef typename TDS_2::Face_handle Face_handle;
typedef typename TDS_2::Face_iterator Face_iterator;
typedef typename std::list<Point_3>::iterator P3_iterator;
@ -639,8 +636,6 @@ public:
}
void operator()( HDS& hds) {
// Postcondition: `hds' is a valid polyhedral surface.
typedef typename HDS::Vertex Vertex;
typedef typename Vertex::Point Point;
CGAL::Polyhedron_incremental_builder_3<HDS> B( hds, true);
Vertex_map vertex_map;
@ -755,7 +750,6 @@ convex_hull_3(InputIterator first, InputIterator beyond,
Object& ch_object, const Traits& traits)
{
typedef typename Traits::Point_3 Point_3;
typedef typename Traits::Plane_3 Plane_3;
typedef std::list<Point_3> Point_3_list;
typedef typename Point_3_list::iterator P3_iterator;
typedef std::pair<P3_iterator,P3_iterator> P3_iterator_pair;
@ -868,7 +862,6 @@ void convex_hull_3(InputIterator first, InputIterator beyond,
Object& ch_object)
{
typedef typename std::iterator_traits<InputIterator>::value_type Point_3;
typedef typename Kernel_traits<Point_3>::Kernel K;
typedef typename internal::Convex_hull_3::Default_traits_for_Chull_3<Point_3>::type Traits;
convex_hull_3(first, beyond, ch_object, Traits());
}
@ -880,7 +873,6 @@ void convex_hull_3(InputIterator first, InputIterator beyond,
Polyhedron_3& polyhedron, const Traits& traits)
{
typedef typename Traits::Point_3 Point_3;
typedef typename Traits::Plane_3 Plane_3;
typedef std::list<Point_3> Point_3_list;
typedef typename Point_3_list::iterator P3_iterator;

View File

@ -31,9 +31,6 @@ Object plane_half_plane_proj_intersection(const typename K::Plane_3 &h1,
const typename K::Line_2 &l,
const K& k)
{
typedef typename K::Vector_2 Vector_2;
typedef typename K::Point_2 Point_2;
typedef typename K::Ray_2 Ray_2;
typedef typename K::Line_3 Line_3;
typedef typename K::Line_2 Line_2;
typedef typename K::Plane_3 Plane_3;
@ -92,7 +89,6 @@ typename K::Line_2 project_xy(const typename K::Line_3& l,
typedef typename K::Vector_2 Vector_2;
typedef typename K::Point_3 Point_3;
typedef typename K::Point_2 Point_2;
typedef typename K::Ray_2 Ray_2;
Vector_3 vec3 = k.construct_vector_3_object()(l);
Vector_2 vec2(vec3.x(), vec3.y());
@ -157,10 +153,8 @@ Object ray_under_linear_constraint(const typename K::Ray_2& ray,
const K& k)
{
typedef typename K::Ray_2 Ray_2;
typedef typename K::Line_2 Line_2;
typedef typename K::Vector_2 Vector_2;
typedef typename K::Point_2 Point_2;
typedef typename K::Segment_2 Segment_2;
const Point_2& s = k.construct_point_on_2_object()(ray, 0);
Oriented_side side = k.oriented_side_2_object()(l, s);

View File

@ -47,7 +47,6 @@ OutputIterator random_polygon_2(std::size_t n, OutputIterator result,
{
typedef typename Traits::Point_2 Point_2;
typedef std::vector<Point_2> Vertex_list;
typedef typename Vertex_list::iterator Iterator;
Vertex_list vertices;

View File

@ -739,7 +739,6 @@ namespace HomogeneousKernelFunctors {
result_type
operator()(const Line_2& l1, const Line_2& l2) const
{
typedef typename K::RT RT;
if (l1.is_horizontal())
return l2.is_vertical() ?
SMALLER : CGAL_NTS sign(l2.a()) * CGAL_NTS sign(l2.b());
@ -1047,7 +1046,6 @@ namespace HomogeneousKernelFunctors {
result_type
operator()( const Point_2& p, const Line_2& h) const
{
typedef typename K::RT RT;
CGAL_kernel_precondition( ! h.is_vertical() );
typename K::Oriented_side ors = h.oriented_side( p );
if ( h.b() < 0 )

View File

@ -84,7 +84,6 @@ protected:
{
//std::cout << "Drawing del\n";
typedef typename Kinetic_Delaunay::Triangulation Del;
typedef typename Del::Geom_traits::Point_2 Point_key;
const Del &tri= kdel_->triangulation(typename Del::Geom_traits::Time(t));
//tri.geom_traits().set_time(typename Del::Geom_traits::Time(t));
w << CGAL::LineWidth(1);

View File

@ -170,7 +170,6 @@ template <class T, class G>
void Qt_moving_points_2<T,G>::draw() const
{
//std::cout << "Drawing mpt MPT\n";
typedef typename Traits::Static_kernel::Point_2 P2;
typedef typename Traits::Static_kernel::Circle_2 C;
typedef typename Traits::Kinetic_kernel::Is_constant IC;
IC ic = traits_.kinetic_kernel_object().is_constant_object();
@ -191,6 +190,7 @@ void Qt_moving_points_2<T,G>::draw() const
} else {
w << CGAL::PointSize(std::max BOOST_PREVENT_MACRO_SUBSTITUTION(ptsz_/8, 1)) << CGAL::LineWidth(1);
}
// typedef typename Traits::Static_kernel::Point_2 P2;
//out << C(P2(0,0), 2) << C(P2(0,0), 1);
//out << CGAL::BackgroundColor(CGAL::Color(125,125,125));

View File

@ -492,7 +492,6 @@ two_cover_points(
using std::less;
typedef typename Traits::FT FT;
typedef typename Traits::Point_2 Point_2;
typename Traits::Infinity_distance_2 dist =
d.traits.infinity_distance_2_object();
typename Traits::Signed_infinity_distance_2 sdist =

View File

@ -865,7 +865,6 @@ rectangular_3_center_2_type2(
using std::pair;
typedef typename Operations::Point Point;
typedef typename Operations::Distance Distance;
typedef pair< RandomAccessIterator, RandomAccessIterator > IP;
typename Operations::Construct_iso_rectangle_2

View File

@ -161,9 +161,7 @@ sorted_matrix_search(InputIterator f, InputIterator l, Traits t)
typedef Matrix_cell< PaddedMatrix > Cell;
typedef std::vector< Cell > Cell_container;
typedef typename Cell_container::iterator Cell_iterator;
typedef typename Cell_container::reverse_iterator Cell_reverse_iterator;
typedef typename Cell_container::size_type size_type ;
// typedef typename Cell_container::reverse_iterator Cell_reverse_iterator;
Cell_container active_cells;

View File

@ -77,9 +77,6 @@ public:
typedef typename Geom_traits::Compute_area_2 Compute_area_2;
typedef typename Geom_traits::Compute_squared_distance_2
Compute_squared_distance_2;
typedef typename Geom_traits::Construct_triangle_2
Construct_triangle_2;
typedef typename Geom_traits::FT FT;
Compute_area_2 area_2 =
traits.compute_area_2_object();

View File

@ -114,9 +114,6 @@ public:
typedef typename Geom_traits::Compute_area_2 Compute_area_2;
typedef typename Geom_traits::Compute_squared_distance_2
Compute_squared_distance_2;
typedef typename Geom_traits::Construct_triangle_2
Construct_triangle_2;
typedef typename Geom_traits::FT FT;
Geom_traits traits; /** @warning traits with data!! */

View File

@ -296,9 +296,6 @@ public:
{
typedef typename Cluster_map::const_iterator Iterator;
typedef std::pair<Iterator, Iterator> Range;
typedef typename Range::first_type Clusters_iterator;
typedef Pair_get_first<typename Cluster_vertices_map::value_type>
Get_first;
Range range = cluster_map.equal_range(vh);
Iterator first = range.first;

View File

@ -197,8 +197,6 @@ bool
Detect_features_in_polyhedra<P_>::
is_sharp(const Halfedge_handle& he, FT cos_angle) const
{
typedef typename Geom_traits::FT FT;
Facet_handle f1 = he->facet();
Facet_handle f2 = he->opposite()->facet();
if(f1 == NULL || f2 == NULL)

View File

@ -806,8 +806,6 @@ non_adjacent_but_intersect(const Vertex_handle& va, const Vertex_handle& vb) con
{
if ( ! c3t3_.is_in_complex(va,vb) )
{
typedef typename Gt::Sphere_3 Sphere_3;
typename Gt::Construct_sphere_3 sphere =
c3t3_.triangulation().geom_traits().construct_sphere_3_object();

View File

@ -397,7 +397,6 @@ protected:
{
typedef typename Tr::Vertex_handle Vertex_handle;
typedef typename Tr::Cell_handle Cell_handle;
typedef typename Tr::Vertex::Index Index;
const Cell_handle& ch = f.first;
const int i = f.second;

View File

@ -34,7 +34,6 @@ radius_ratio(const typename K::Point_3& p0,
K k = K())
{
typedef typename K::FT FT;
typedef typename K::Point_3 Point_3;
typename K::Compute_squared_distance_3 sq_distance =
k.compute_squared_distance_3_object();
typename K::Compute_squared_radius_3 comp_sq_circumradius =

View File

@ -569,7 +569,6 @@ is_valid() const
const Bare_point& p = it->right->point().point();
const Bare_point& q = it->left->point().point();
typedef typename Tr::Geom_traits::Sphere_3 Sphere_3;
typename Tr::Geom_traits::Construct_sphere_3 sphere =
this->triangulation().geom_traits().construct_sphere_3_object();

View File

@ -554,9 +554,6 @@ Polyhedral_mesh_domain_3<P_,IGT_,TA,Tag,E_tag_>::
Construct_initial_points::operator()(OutputIterator pts,
const int n) const
{
typedef boost::optional<typename AABB_tree_::Object_and_primitive_id>
AABB_intersection;
typename IGT::Construct_ray_3 ray = IGT().construct_ray_3_object();
typename IGT::Construct_vector_3 vector = IGT().construct_vector_3_object();

View File

@ -64,7 +64,6 @@ lloyd_optimize_mesh_3_impl(C3T3& c3t3,
const double freeze_bound)
{
typedef typename C3T3::Triangulation Tr;
typedef typename Tr::Geom_traits Gt;
typedef Mesh_3::Mesh_sizing_field<Tr> Sizing;
typedef typename Mesh_3::Lloyd_move<C3T3,Sizing> Move;

View File

@ -65,7 +65,6 @@ odt_optimize_mesh_3_impl(C3T3& c3t3,
const double freeze_ratio)
{
typedef typename C3T3::Triangulation Tr;
typedef typename Tr::Geom_traits Gt;
typedef Mesh_3::Mesh_sizing_field<Tr> Sizing;
typedef typename Mesh_3::Odt_move<C3T3,Sizing> Move;

View File

@ -310,7 +310,6 @@ void refine_mesh_3_impl(C3T3& c3t3,
bool reset_c3t3)
{
typedef Mesh_3::Mesher_3<C3T3, MeshCriteria, MeshDomain> Mesher;
typedef typename C3T3::Triangulation::Geom_traits Gt;
// Reset c3t3 (i.e. remove weights) if needed
if ( reset_c3t3 )

View File

@ -150,7 +150,6 @@ inset_polygon_2 (const Polygon_2<typename ConicTraits::Rat_kernel,
{
typedef Exact_offset_base_2<ConicTraits, Container> Base;
typedef Offset_by_convolution_2<Base> Exact_offset_2;
typedef typename Exact_offset_2::Offset_polygon_2 Offset_polygon_2;
Base base;
Exact_offset_2 exact_offset (base);

View File

@ -306,14 +306,13 @@ inline std::ostream& operator << (std::ostream& os, const Residue& p) {
}
inline std::istream& operator >> (std::istream& is, Residue& p) {
typedef Residue RES;
char ch;
int prime;
is >> p.x();
is >> ch; // read the %
is >> prime; // read the prime
CGAL_precondition(prime==RES::get_current_prime());
CGAL_precondition(prime==Residue::get_current_prime());
return is;
}

View File

@ -432,8 +432,6 @@ check_integrity_and_topological_planarity(bool faces) const
EI(halfedges_begin(),halfedges_end(),'e');
Object_index<Face_const_iterator>
FI(faces_begin(),faces_end(),'f');
typedef Halfedge_around_vertex_const_circulator hvc_circulator;
typedef Halfedge_around_face_const_circulator hfc_circulator;
Vertex_const_handle vit, vend = phds->vertices_end();
int iso_vert_num=0;
/* check the source links of out edges and count isolated vertices */

View File

@ -782,10 +782,6 @@ public:
typedef typename SNC_structure::Vertex_iterator Vertex_iterator;
typedef typename SNC_structure::Halfedge_iterator Halfedge_iterator;
typedef typename SNC_structure::Halffacet_iterator Halffacet_iterator;
typedef typename SNC_structure::Halffacet_cycle_iterator
Halffacet_cycle_iterator;
typedef typename SNC_structure::SHalfedge_around_facet_circulator
SHalfedge_around_facet_circulator;
CGAL_assertion( W != NULL);
Object_list objects;
@ -799,6 +795,10 @@ public:
objects.push_back(make_object(Halfedge_handle(e)));
CGAL_forall_facets( f, *W) {
#ifdef CGAL_NEF3_TRIANGULATE_FACETS
typedef typename SNC_structure::SHalfedge_around_facet_circulator
SHalfedge_around_facet_circulator;
typedef typename SNC_structure::Halffacet_cycle_iterator
Halffacet_cycle_iterator;
Halffacet_cycle_iterator fci = f->facet_cycles_begin();
CGAL_assertion(fci.is_shalfedge());

View File

@ -498,7 +498,6 @@ public:
Vertex_handle create_from_plane(const Plane_3& pl, const Point_3& p,
const Mark& bnd,
const Mark& in, const Mark& out) const {
typedef typename CGAL::SNC_const_decorator<SNC_structure> SNC_const_decorator;
Vertex_handle v = this->sncp()->new_vertex( p, bnd);
v->point() = p;
Sphere_circle c(pl); // circle through origin parallel to h

View File

@ -712,7 +712,6 @@ class Geometry_io<Cartesian_tag, Kernel> {
void print_point(std::ostream& out, const CGAL::Point_3<R> p) {
typedef Fraction_traits<typename R::FT> FracTraits;
typedef std::vector<typename FracTraits::Numerator_type> NV;
typedef typename NV::iterator NV_iter;
typename FracTraits::Numerator_type num;
typename FracTraits::Denominator_type denom;
@ -745,7 +744,6 @@ class Geometry_io<Cartesian_tag, Kernel> {
typedef Fraction_traits<typename R::FT> FracTraits;
typedef typename FracTraits::Numerator_type NumType;
typedef std::vector<NumType> NV;
typedef typename NV::iterator NV_iter;
typename FracTraits::Numerator_type num;
typename FracTraits::Denominator_type denom;
@ -774,7 +772,6 @@ class Geometry_io<Cartesian_tag, Kernel> {
void print_plane(std::ostream& out, const CGAL::Plane_3<R> p) {
typedef Fraction_traits<typename R::FT> FracTraits;
typedef std::vector<typename FracTraits::Numerator_type> NV;
typedef typename NV::iterator NV_iter;
typename FracTraits::Numerator_type num;
typename FracTraits::Denominator_type denom;

View File

@ -179,7 +179,6 @@ void polyhedron_3_to_nef_3(Polyhedron_& P, SNC_structure& S)
typedef Polyhedron_ Polyhedron;
typedef typename Polyhedron::Facet::Plane_3 Plane;
typedef typename Polyhedron::Traits::Kernel Kernel;
typedef typename SNC_structure::SNC_decorator SNC_decorator;
typedef typename SNC_structure::SM_decorator SM_decorator;
typedef typename SNC_structure::Vertex_handle Vertex_handle;
typedef typename SNC_structure::SVertex_handle SVertex_handle;
@ -187,7 +186,6 @@ void polyhedron_3_to_nef_3(Polyhedron_& P, SNC_structure& S)
typedef typename SNC_structure::SFace_handle SFace_handle;
typedef typename SNC_structure::Point_3 Point_3;
typedef typename SNC_structure::Sphere_point Sphere_point;
typedef typename SNC_structure::Sphere_segment Sphere_segment;
typedef typename SNC_structure::Sphere_circle Sphere_circle;
typedef typename Polyhedron::Halfedge_around_vertex_const_circulator

View File

@ -158,16 +158,10 @@ bool projected_vertex_cycle_to_nef_3 (typename Nef_3::SNC_structure &snc,
typedef typename SNC_structure::SHalfedge_handle SHalfedge_handle;
typedef typename SNC_structure::SFace_handle SFace_handle;
typedef typename SNC_structure::Kernel Kernel;
typedef typename SNC_structure::Point_3 Point_3;
typedef typename std::pair<CTP_vertex*, CTP_vertex*> Point_pair;
typedef Compare_cpte<CTP_vertex> Compare_edge;
typedef CGAL::SNC_point_locator_by_spatial_subdivision
<CGAL::SNC_decorator<SNC_structure> > Point_locator;
typedef typename SNC_structure::Items Items;
typedef CGAL::SNC_constructor<Items, SNC_structure> SNC_constructor;
// declarations and defaults
II v_it, v_pred_it;

View File

@ -291,7 +291,6 @@ class Normalizing<Cartesian_tag> {
typedef typename R::FT FT;
typedef Fraction_traits<FT> FracTraits;
typedef std::vector<typename FracTraits::Numerator_type> NV;
typedef typename NV::iterator NV_iter;
typename FracTraits::Numerator_type num;
typename FracTraits::Denominator_type denom;

View File

@ -294,8 +294,6 @@ check_integrity_and_topological_planarity(bool faces) const
EI(shalfedges_begin(),shalfedges_end(),'e');
Object_index<SFace_const_iterator>
FI(sfaces_begin(),sfaces_end(),'f');
typedef SHalfedge_around_svertex_const_circulator hvc_circulator;
typedef SHalfedge_around_sface_const_circulator hfc_circulator;
SVertex_const_handle v;
int iso_vert_num=0;
/* check the source links of out edges and count isolated vertices */

View File

@ -135,7 +135,6 @@ OutputIterator partition_approx_convex_2(InputIterator first,
typedef Triangulation_indirect_traits_2<Circulator, Traits> Gt;
typedef Constrained_triangulation_2<Gt> Constrained_tri_2;
typedef typename Constrained_tri_2::Edge_iterator Edge_iterator;
typedef typename Constrained_tri_2::Edge_circulator Edge_circulator;
typedef typename Constrained_tri_2::Vertex_iterator Tri_vertex_iterator;
typedef typename Constrained_tri_2::Vertex_handle Vertex_handle;

View File

@ -361,7 +361,6 @@ void change_top_chain(Polygon& polygon,
{
std::copy(new_point_ref, stack.before_front(),
std::back_inserter(new_polygon));
typedef typename Polygon::iterator iterator;
erase_vertices(top_chain.front(), stack.front(), polygon,
update_required);
top_chain.push_front(stack.front());
@ -801,7 +800,6 @@ OutputIterator partition_greene_approx_convex_2(InputIterator first,
{
if (first == beyond) return result;
typedef typename Traits::Point_2 Point_2;
typedef typename Traits::Polygon_2 Polygon_2;
#if defined(CGAL_PARTITION_NO_POSTCONDITIONS) || \

View File

@ -205,7 +205,6 @@ bool collinearly_visible(unsigned int edge_num1, unsigned int e_num,
const Polygon& polygon,
const Traits& traits)
{
typedef typename Polygon::size_type size_type;
typedef typename Traits::Orientation_2 Orientation_2;
Orientation_2 orientation = traits.orientation_2_object();
@ -447,7 +446,6 @@ void partition_opt_cvx_preprocessing(Polygon& polygon,
{
typedef typename Polygon::size_type size_type;
typedef typename Polygon::iterator Vertex_iterator;
typedef Vertex_visibility_graph_2<Traits> Vis_graph;
typedef typename Traits::Point_2 Point_2;
typedef std::pair<Point_2, Point_2> Point_pair;

View File

@ -2532,7 +2532,6 @@ inline void Periodic_3_triangulation_3<GT,TDS>::periodic_remove(Vertex_handle v,
// with the facet just behind
typedef std::map<Vertex_triple,Facet> Vertex_triple_Facet_map;
typedef PointRemover Point_remover;
typedef typename Point_remover::TDSE TDSE;
typedef typename Point_remover::CellE_handle CellE_handle;
typedef typename Point_remover::VertexE_handle VertexE_handle;
typedef typename Point_remover::FacetE FacetE;
@ -2541,8 +2540,6 @@ inline void Periodic_3_triangulation_3<GT,TDS>::periodic_remove(Vertex_handle v,
Finite_cellsE_iterator;
typedef typename Point_remover::Vertex_triple_FacetE_map
Vertex_triple_FacetE_map;
typedef typename Point_remover::Vertex_triple_FacetE_map_it
Vertex_triple_FacetE_map_it;
// First compute the hole and its boundary vertices.
std::vector<Cell_handle> hole;
@ -3020,7 +3017,6 @@ Periodic_3_triangulation_3<GT,TDS>::convert_to_27_sheeted_covering() {
Virtual_cell_map;
typedef std::map<Cell_handle, std::vector<Cell_handle > >
Virtual_cell_reverse_map;
typedef typename Virtual_cell_map::const_iterator VCMIT;
typedef typename Virtual_cell_reverse_map::const_iterator VCRMIT;
Virtual_cell_map virtual_cells;
@ -3555,8 +3551,6 @@ operator<< (std::ostream& os,const Periodic_3_triangulation_3<GT,TDS> &tr)
typedef typename Triangulation::Vertex_iterator Vertex_iterator;
typedef typename Triangulation::Cell_handle Cell_handle;
typedef typename Triangulation::Cell_iterator Cell_iterator;
typedef typename Triangulation::Edge_iterator Edge_iterator;
typedef typename Triangulation::Facet_iterator Facet_iterator;
typedef typename Triangulation::Covering_sheets Covering_sheets;
typedef typename Triangulation::Offset Offset;
typedef typename Triangulation::Virtual_vertex_map_it Virtual_vertex_map_it;
@ -3754,9 +3748,9 @@ operator==(const Periodic_3_triangulation_3<GT,TDS1> &t1,
typedef typename Periodic_3_triangulation_3<GT,TDS1>::Point Point;
typedef typename Periodic_3_triangulation_3<GT,TDS1>::Offset Offset;
typedef typename Periodic_3_triangulation_3<GT,TDS1>
::Geometric_traits::Compare_xyz_3 Compare_xyz_3;
// typedef typename Periodic_3_triangulation_3<GT,TDS1>
// ::Geometric_traits::Compare_xyz_3 Compare_xyz_3;
// Compare_xyz_3 cmp1 = t1.geom_traits().compare_xyz_3_object();
// Compare_xyz_3 cmp2 = t2.geom_traits().compare_xyz_3_object();

View File

@ -56,8 +56,6 @@ compute_average_spacing(const typename Kernel::Point_3& query, ///< 3D point who
// basic geometric types
typedef typename Kernel::FT FT;
typedef typename Kernel::Point_3 Point;
typedef typename Kernel::Plane_3 Plane;
typedef typename Kernel::Vector_3 Vector;
// types for K nearest neighbors search
typedef Search_traits_3<Kernel> Tree_traits;

View File

@ -61,7 +61,6 @@ jet_estimate_normal(const typename Kernel::Point_3& query, ///< point to compute
{
// basic geometric types
typedef typename Kernel::Point_3 Point;
typedef typename Kernel::Vector_3 Vector;
// types for K nearest neighbors search
typedef typename CGAL::Search_traits_3<Kernel> Tree_traits;

View File

@ -420,10 +420,6 @@ create_mst_graph(
// Bring private stuff to scope
using namespace internal;
// Input points types
typedef typename boost::property_traits<PointPMap>::value_type Point;
typedef typename boost::property_traits<NormalPMap>::value_type Vector;
// Riemannian_graph types
typedef internal::Riemannian_graph<ForwardIterator> Riemannian_graph;
typedef typename boost::property_map<Riemannian_graph, boost::edge_weight_t>::const_type Riemannian_graph_weight_map;
@ -535,8 +531,6 @@ mst_orient_normals(
// Input points types
typedef typename std::iterator_traits<ForwardIterator>::value_type Enriched_point; // actual type of input points
typedef typename boost::property_traits<NormalPMap>::value_type Vector;
// Property map ForwardIterator -> index
typedef Index_property_map<ForwardIterator> IndexPMap;

View File

@ -62,7 +62,6 @@ pca_estimate_normal(const typename Kernel::Point_3& query, ///< point to compute
// basic geometric types
typedef typename Kernel::Point_3 Point;
typedef typename Kernel::Plane_3 Plane;
typedef typename Kernel::Vector_3 Vector;
// types for K nearest neighbors search
typedef typename CGAL::Search_traits_3<Kernel> Tree_traits;

View File

@ -146,7 +146,6 @@ remove_outliers(
typedef typename CGAL::Search_traits_3<Kernel> Tree_traits;
typedef typename CGAL::Orthogonal_k_neighbor_search<Tree_traits> Neighbor_search;
typedef typename Neighbor_search::Tree Tree;
typedef typename Neighbor_search::iterator Search_iterator;
// precondition: at least one element in the container.
// to fix: should have at least three distinct points

View File

@ -289,8 +289,6 @@ Scene_item* cgal_code_mesh_3(const Polyhedron* pMesh,
// remesh
typedef Tr::Geom_traits GT;
// Set mesh criteria
Facet_criteria facet_criteria(angle, sizing, approx); // angle, size, approximation
Cell_criteria cell_criteria(4, tets_sizing); // radius-edge ratio, size

View File

@ -17,7 +17,6 @@ Scene_combinatorial_map_item* Scene_combinatorial_map_item::clone() const{return
Kernel::Vector_3 Scene_combinatorial_map_item::compute_face_normal(Combinatorial_map_3::Dart_const_handle adart) const
{
typedef Combinatorial_map_3::Dart_of_orbit_const_range<1> Dart_in_facet_range;
typedef Kernel::Point_3 Point_3;
typedef Kernel::Vector_3 Vector_3;
Vector_3 normal = CGAL::NULL_VECTOR;

View File

@ -169,7 +169,6 @@ void extract_connected_components(const Polyhedron& P,const Adjacency_criterium&
typedef typename Polyhedron::Facet_const_handle Facet_const_handle;
typedef ::CGAL::Union_find<Facet_const_handle> UF;
typedef typename UF::handle UF_handle;
typedef typename UF::iterator UF_iterator;
typedef std::map<Facet_const_handle,std::list<Facet_const_handle>,Compare_handle_ptr<Polyhedron> > Result;
typedef std::map<Facet_const_handle,UF_handle,Compare_handle_ptr<Polyhedron> > Facet_to_handle_map;

View File

@ -492,8 +492,6 @@ void sew_2_marked_darts( Combinatorial_map_3& final_map,
const std::pair<int,int>& indices,
const std::pair<bool,int>& polyline_info)
{
typedef boost::optional<typename Combinatorial_map_3::Dart_handle> O_Dart_handle;
CGAL_precondition( dart_1->is_free(2) );
CGAL_precondition( dart_2->is_free(2) );
CGAL_precondition( final_map.is_marked(dart_1,mark_index) );
@ -1836,7 +1834,6 @@ public:
typedef typename Polyhedron::Facet_const_handle Facet_const_handle;
typedef ::CGAL::Union_find<Facet_const_handle> UF;
typedef typename UF::handle UF_handle;
typedef typename UF::iterator UF_iterator;
typedef std::map<Facet_const_handle,std::list<Facet_const_handle>,internal::Compare_handle_ptr<Polyhedron> > Result;
typedef std::map<Facet_const_handle,UF_handle,internal::Compare_handle_ptr<Polyhedron> > Facet_to_handle_map;

View File

@ -66,9 +66,6 @@ Polynomial<NT> modular_gcd_utcf_algorithm_M(
timer_init.start();
#endif
typedef Polynomial<NT> Poly;
typedef Polynomial_traits_d<Poly> PT;
typedef typename PT::Innermost_coefficient_type IC;
// will paly the role of content
typedef typename CGAL::Scalar_factor_traits<Poly>::Scalar Scalar;

View File

@ -38,7 +38,6 @@ inline
Polynomial<NT> gcd_utcf_UFD(
Polynomial<NT> p1, Polynomial<NT> p2
) {
typedef CGAL::Polynomial_traits_d<Polynomial<NT> > PT;
// implemented using the subresultant algorithm for gcd computation
// see [Cohen, 1993], algorithm 3.3.1
// handle trivial cases

View File

@ -39,7 +39,6 @@ namespace CGAL {
typename Polynomial_traits_d::Polynomial_d B,
typename Polynomial_traits_d::Polynomial_d& C) {
typedef typename Polynomial_traits_d::Polynomial_d Polynomial;
typedef typename Polynomial_traits_d::Coefficient_type NT;
typename CGAL::Algebraic_structure_traits<NT>::Integral_division idiv;

View File

@ -1660,7 +1660,6 @@ struct Construct_innermost_coefficient_const_iterator_range
typedef std::iterator_traits<Input_iterator> ITT;
typedef typename ITT::value_type value_type;
typedef Coercion_traits<value_type, Innermost_coefficient_type> CT;
typedef typename CT::Type Type;
typename PTC::Substitute_homogeneous subsh;

View File

@ -97,8 +97,6 @@ assemble_covariance_matrix_3(InputIterator first,
const CGAL::Dimension_tag<2>&)
{
typedef typename K::FT FT;
typedef typename K::Point_3 Point;
typedef typename K::Vector_3 Vector;
typedef typename K::Triangle_3 Triangle;
typedef typename CGAL::Linear_algebraCd<FT> LA;
typedef typename LA::Matrix Matrix;
@ -176,8 +174,6 @@ assemble_covariance_matrix_3(InputIterator first,
const CGAL::Dimension_tag<3>&)
{
typedef typename K::FT FT;
typedef typename K::Point_3 Point;
typedef typename K::Vector_3 Vector;
typedef typename K::Iso_cuboid_3 Iso_cuboid;
typedef typename CGAL::Linear_algebraCd<FT> LA;
typedef typename LA::Matrix Matrix;
@ -263,8 +259,6 @@ assemble_covariance_matrix_3(InputIterator first,
const CGAL::Dimension_tag<2>&)
{
typedef typename K::FT FT;
typedef typename K::Point_3 Point;
typedef typename K::Vector_3 Vector;
typedef typename K::Iso_cuboid_3 Iso_cuboid;
typedef typename CGAL::Linear_algebraCd<FT> LA;
typedef typename LA::Matrix Matrix;
@ -358,8 +352,6 @@ assemble_covariance_matrix_3(InputIterator first,
const CGAL::Dimension_tag<3>&)
{
typedef typename K::FT FT;
typedef typename K::Point_3 Point;
typedef typename K::Vector_3 Vector;
typedef typename K::Sphere_3 Sphere;
typedef typename CGAL::Linear_algebraCd<FT> LA;
typedef typename LA::Matrix Matrix;
@ -442,8 +434,6 @@ assemble_covariance_matrix_3(InputIterator first,
const CGAL::Dimension_tag<2>&)
{
typedef typename K::FT FT;
typedef typename K::Point_3 Point;
typedef typename K::Vector_3 Vector;
typedef typename K::Sphere_3 Sphere;
typedef typename CGAL::Linear_algebraCd<FT> LA;
typedef typename LA::Matrix Matrix;
@ -528,8 +518,6 @@ assemble_covariance_matrix_3(InputIterator first,
const CGAL::Dimension_tag<3>&)
{
typedef typename K::FT FT;
typedef typename K::Point_3 Point;
typedef typename K::Vector_3 Vector;
typedef typename K::Tetrahedron_3 Tetrahedron;
typedef typename CGAL::Linear_algebraCd<FT> LA;
typedef typename LA::Matrix Matrix;
@ -615,8 +603,6 @@ assemble_covariance_matrix_3(InputIterator first,
const CGAL::Dimension_tag<1>&)
{
typedef typename K::FT FT;
typedef typename K::Point_3 Point;
typedef typename K::Vector_3 Vector;
typedef typename K::Segment_3 Segment;
typedef typename CGAL::Linear_algebraCd<FT> LA;
typedef typename LA::Matrix Matrix;
@ -694,7 +680,6 @@ fitting_plane_3(const typename K::FT covariance[6], // covariance matrix
const K& ) // kernel
{
typedef typename K::FT FT;
typedef typename K::Point_3 Point;
typedef typename K::Plane_3 Plane;
typedef typename K::Vector_3 Vector;
@ -736,7 +721,6 @@ fitting_line_3(const typename K::FT covariance[6], // covariance matrix
const K&) // kernel
{
typedef typename K::FT FT;
typedef typename K::Point_3 Point;
typedef typename K::Line_3 Line;
typedef typename K::Vector_3 Vector;

View File

@ -54,7 +54,6 @@ linear_least_squares_fitting_2(InputIterator first,
// types
typedef typename K::FT FT;
typedef typename K::Line_2 Line;
typedef typename K::Point_2 Point;
typedef typename K::Vector_2 Vector;
typedef typename K::Circle_2 Circle;
typedef typename CGAL::Linear_algebraCd<FT> LA;
@ -163,7 +162,6 @@ linear_least_squares_fitting_2(InputIterator first,
// types
typedef typename K::FT FT;
typedef typename K::Line_2 Line;
typedef typename K::Point_2 Point;
typedef typename K::Vector_2 Vector;
typedef typename K::Circle_2 Circle;
typedef typename CGAL::Linear_algebraCd<FT> LA;

View File

@ -109,7 +109,6 @@ linear_least_squares_fitting_3(InputIterator first,
const K& k, // kernel
const CGAL::Dimension_tag<1>& tag)
{
typedef typename K::FT FT;
typedef typename K::Segment_3 Segment;
typedef typename K::Iso_cuboid_3 Iso_cuboid;
@ -153,7 +152,6 @@ linear_least_squares_fitting_3(InputIterator first,
const K& k, // kernel
const CGAL::Dimension_tag<0>& tag)
{
typedef typename K::FT FT;
typedef typename K::Point_3 Point;
typedef typename K::Iso_cuboid_3 Iso_cuboid;
@ -254,7 +252,6 @@ linear_least_squares_fitting_3(InputIterator first,
const K& k, // kernel
const CGAL::Dimension_tag<1>& tag)
{
typedef typename K::FT FT;
typedef typename K::Segment_3 Segment;
typedef typename K::Iso_cuboid_3 Iso_cuboid;
@ -298,7 +295,6 @@ linear_least_squares_fitting_3(InputIterator first,
const K& k, // kernel
const CGAL::Dimension_tag<0>& tag)
{
typedef typename K::FT FT;
typedef typename K::Point_3 Point;
typedef typename K::Iso_cuboid_3 Iso_cuboid;

View File

@ -48,8 +48,6 @@ linear_least_squares_fitting_3(InputIterator first,
{
typedef typename K::FT FT;
typedef typename K::Point_3 Point;
typedef typename K::Plane_3 Plane;
typedef typename K::Vector_3 Vector;
// precondition: at least one element in the container.
CGAL_precondition(first != beyond);
@ -82,8 +80,6 @@ linear_least_squares_fitting_3(InputIterator first,
{
typedef typename K::FT FT;
typedef typename K::Point_3 Point;
typedef typename K::Line_3 Line;
typedef typename K::Vector_3 Vector;
// precondition: at least one element in the container.
CGAL_precondition(first != beyond);

View File

@ -54,12 +54,10 @@ linear_least_squares_fitting_2(InputIterator first,
// types
typedef typename K::FT FT;
typedef typename K::Line_2 Line;
typedef typename K::Point_2 Point;
typedef typename K::Vector_2 Vector;
typedef typename K::Iso_rectangle_2 Iso_rectangle;
typedef typename CGAL::Linear_algebraCd<FT> LA;
typedef typename LA::Matrix Matrix;
typedef typename K::Segment_2 Segment_2;
// precondition: at least one element in the container.
CGAL_precondition(first != beyond);

View File

@ -54,7 +54,6 @@ linear_least_squares_fitting_2(InputIterator first,
// types
typedef typename K::FT FT;
typedef typename K::Line_2 Line;
typedef typename K::Point_2 Point;
typedef typename K::Vector_2 Vector;
typedef typename K::Segment_2 Segment;
typedef typename CGAL::Linear_algebraCd<FT> LA;

View File

@ -75,7 +75,6 @@ linear_least_squares_fitting_3(InputIterator first,
const K& k, // kernel
const CGAL::Dimension_tag<0>& tag)
{
typedef typename K::FT FT;
typedef typename K::Segment_3 Segment;
typedef typename K::Point_3 Point;
@ -139,7 +138,6 @@ linear_least_squares_fitting_3(InputIterator first,
const K& k, // kernel
const CGAL::Dimension_tag<0>& tag)
{
typedef typename K::FT FT;
typedef typename K::Segment_3 Segment;
typedef typename K::Point_3 Point;

View File

@ -77,7 +77,6 @@ linear_least_squares_fitting_3(InputIterator first,
const K& k, // kernel
const CGAL::Dimension_tag<2>& tag)
{
typedef typename K::FT FT;
typedef typename K::Tetrahedron_3 Tetrahedron;
typedef typename K::Triangle_3 Triangle;
@ -113,7 +112,6 @@ linear_least_squares_fitting_3(InputIterator first,
const K& k, // kernel
const CGAL::Dimension_tag<1>& tag)
{
typedef typename K::FT FT;
typedef typename K::Tetrahedron_3 Tetrahedron;
typedef typename K::Segment_3 Segment;
@ -151,7 +149,6 @@ linear_least_squares_fitting_3(InputIterator first,
const K& k, // kernel
const CGAL::Dimension_tag<0>& tag)
{
typedef typename K::FT FT;
typedef typename K::Tetrahedron_3 Tetrahedron;
typedef typename K::Point_3 Point;
@ -217,7 +214,6 @@ linear_least_squares_fitting_3(InputIterator first,
const K& k, // kernel
const CGAL::Dimension_tag<2>& tag)
{
typedef typename K::FT FT;
typedef typename K::Tetrahedron_3 Tetrahedron;
typedef typename K::Triangle_3 Triangle;
@ -253,7 +249,6 @@ linear_least_squares_fitting_3(InputIterator first,
const K& k, // kernel
const CGAL::Dimension_tag<1>& tag)
{
typedef typename K::FT FT;
typedef typename K::Tetrahedron_3 Tetrahedron;
typedef typename K::Segment_3 Segment;
@ -291,7 +286,6 @@ linear_least_squares_fitting_3(InputIterator first,
const K& k, // kernel
const CGAL::Dimension_tag<0>& tag)
{
typedef typename K::FT FT;
typedef typename K::Tetrahedron_3 Tetrahedron;
typedef typename K::Point_3 Point;

View File

@ -56,7 +56,6 @@ linear_least_squares_fitting_2(InputIterator first,
// types
typedef typename Kernel::FT FT;
typedef typename Kernel::Line_2 Line;
typedef typename Kernel::Point_2 Point;
typedef typename Kernel::Vector_2 Vector;
typedef typename Kernel::Triangle_2 Triangle;
typedef typename CGAL::Linear_algebraCd<FT> LA;

View File

@ -74,7 +74,6 @@ linear_least_squares_fitting_3(InputIterator first,
const K& k, // kernel
const CGAL::Dimension_tag<1>& tag)
{
typedef typename K::FT FT;
typedef typename K::Triangle_3 Triangle;
typedef typename K::Segment_3 Segment;
@ -109,7 +108,6 @@ linear_least_squares_fitting_3(InputIterator first,
const K& k, // kernel
const CGAL::Dimension_tag<0>& tag)
{
typedef typename K::FT FT;
typedef typename K::Triangle_3 Triangle;
typedef typename K::Point_3 Point;
@ -174,7 +172,6 @@ linear_least_squares_fitting_3(InputIterator first,
const K& k, // kernel
const CGAL::Dimension_tag<1>& tag)
{
typedef typename K::FT FT;
typedef typename K::Triangle_3 Triangle;
typedef typename K::Segment_3 Segment;
@ -209,7 +206,6 @@ linear_least_squares_fitting_3(InputIterator first,
const K& k, // kernel
const CGAL::Dimension_tag<0>& tag)
{
typedef typename K::FT FT;
typedef typename K::Triangle_3 Triangle;
typedef typename K::Point_3 Point;

View File

@ -87,32 +87,17 @@ template <typename T>
CGAL::Qt_widget& operator<<(CGAL::Qt_widget& ws, const Nef_polyhedron_2<T>& P)
{
typedef Nef_polyhedron_2<T> Polyhedron;
typedef typename T::RT RT;
typedef typename T::Standard_RT Standard_RT;
typedef typename T::Standard_segment_2
Standard_segment_2;
typedef typename T::Standard_line_2
Standard_line_2;
typedef typename T::Standard_point_2
Standard_point_2;
typedef typename Polyhedron::Explorer TExplorer;
typedef typename TExplorer::Halfedge_around_face_const_circulator
Halfedge_around_face_const_circulator;
typedef typename TExplorer::Hole_const_iterator
Hole_const_iterator;
typedef typename TExplorer::Isolated_vertex_const_iterator
Isolated_vertex_const_iterator;
typedef typename TExplorer::Ray Ray;
typedef typename TExplorer::Point Point;
typedef typename TExplorer::Vertex_const_handle
Vertex_const_handle;
typedef typename TExplorer::Halfedge_const_handle
Halfedge_const_handle;
typedef typename TExplorer::Face_const_handle
Face_const_handle;
typedef typename TExplorer::Vertex_const_iterator
Vertex_const_iterator;
typedef typename TExplorer::Halfedge_const_iterator
@ -198,6 +183,8 @@ CGAL::Qt_widget& operator<<(CGAL::Qt_widget& ws, const Nef_polyhedron_2<T>& P)
ws.get_painter().drawPolygon(array);
ws.setRasterOp(old_raster);
/*
typedef typename TExplorer::Isolated_vertex_const_iterator
Isolated_vertex_const_iterator;
Isolated_vertex_const_iterator iv_it;
for (iv_it = D.isolated_vertices_begin(fit);
iv_it != D.isolated_vertices_end(fit); ++iv_it) {

View File

@ -149,7 +149,6 @@ compute_one_ring(const Vertex_const_handle v,
std::list<Halfedge_const_handle> &contour,
FT &OneRingSize)
{
typedef typename std::list<Halfedge_const_handle>::const_iterator list_it;
vertex_neigh.push_back(v);
Halfedge_around_vertex_const_circulator he_circ = v->vertex_begin(),
he_end = he_circ;

View File

@ -14,7 +14,6 @@ typedef CGAL::Segment_tree_1<CGAL::Tree_traits_1> SSegment_tree_1_type;
int main()
{
typedef CGAL::Tree_traits_1::Interval Interval;
typedef CGAL::Tree_traits_1::Key Key;
// definition of the one-dimensional segment tree
std::list<Interval> InputList, OutputList, N;

View File

@ -498,7 +498,6 @@ construct_bounding_box()
{
typedef typename Regular::Finite_vertices_iterator Finite_vertices_iterator;
typedef typename Regular::Geom_traits GT;
typedef typename GT::Bare_point Point;
typedef typename GT::Point Weighted_point;
typedef typename GT::FT FT;

View File

@ -527,7 +527,6 @@ find_hot_pixels_and_create_kd_trees(NT pixel_size,
typedef std::pair<Point_2, Hot_pixel *> Point_hot_pixel_pair;
typedef typename std::list<Segment_data>::iterator Segment_data_iter;
typedef std::list<Segment_2> Segment_list;
typedef typename Segment_list::iterator Segment_iter;
typedef typename std::list<Point_2>::const_iterator Point_const_iter;
typedef typename Traits::Construct_segment_2 Construct_segment_2;

View File

@ -889,7 +889,6 @@ public:
typedef typename std::iterator_traits<InputPointIterator>::value_type Input_point;
typedef std::vector<Input_point> Input_point_vector ;
typedef typename Input_point_vector::iterator Input_point_iterator ;
// Remove coincident consecutive vertices
Input_point_vector lList;

View File

@ -553,7 +553,6 @@ optional< Point_2<K> > construct_normal_offset_lines_isecC2 ( intrusive_ptr< Tri
{
typedef typename K::FT FT ;
typedef Point_2<K> Point_2 ;
typedef Line_2<K> Line_2 ;
typedef optional<Line_2> Optional_line_2 ;

View File

@ -47,7 +47,6 @@ create_partial_interior_straight_skeleton_2 ( FT const& aMaxTime
)
{
typedef Straight_skeleton_2<K> Ss ;
typedef boost::shared_ptr<Ss> SsPtr ;
typedef Straight_skeleton_builder_traits_2<K> SsBuilderTraits;

View File

@ -62,7 +62,6 @@ create_interior_straight_skeleton_2 ( PointIterator aOuterContour_VerticesBegin
)
{
typedef Straight_skeleton_2<K> Ss ;
typedef boost::shared_ptr<Ss> SsPtr ;
typedef Straight_skeleton_builder_traits_2<K> SsBuilderTraits;

View File

@ -236,8 +236,6 @@ Uncertain<Comparison_result> compare_offset_lines_isec_timesC2 ( intrusive_ptr<
{
typedef typename K::FT FT ;
typedef Trisegment_2<K> Trisegment_2 ;
typedef Rational<FT> Rational ;
typedef Quotient<FT> Quotient ;
typedef optional<Rational> Optional_rational ;
@ -361,7 +359,6 @@ oriented_side_of_event_point_wrt_bisectorC2 ( intrusive_ptr< Trisegment_2<K> > c
typedef Point_2 <K> Point_2 ;
typedef Line_2 <K> Line_2 ;
typedef Trisegment_2<K> Trisegment_2 ;
Uncertain<Oriented_side> rResult = Uncertain<Oriented_side>::indeterminate();
@ -480,9 +477,6 @@ Uncertain<bool> are_events_simultaneousC2 ( intrusive_ptr< Trisegment_2<K> > con
typedef typename K::FT FT ;
typedef Point_2<K> Point_2 ;
typedef Line_2<K> Line_2 ;
typedef Trisegment_2<K> Trisegment_2 ;
typedef Rational<FT> Rational ;
typedef Quotient<FT> Quotient ;

View File

@ -42,11 +42,6 @@ namespace Subdivision_method_3 {
void PQQ_1step(Poly& p, Mask<Poly> mask) {
typedef Polyhedron_decorator_3<Poly> PD;
typedef typename Poly::Halfedge_data_structure HDS;
typedef typename Poly::Vertex Vertex;
typedef typename Poly::Halfedge Halfedge;
typedef typename Poly::Facet Facet;
typedef typename Poly::Vertex_handle Vertex_handle;
typedef typename Poly::Halfedge_handle Halfedge_handle;
typedef typename Poly::Facet_handle Facet_handle;
@ -168,8 +163,6 @@ namespace Subdivision_method_3 {
typedef Polyhedron_decorator_3<Poly> PD;
typedef typename Poly::Halfedge_data_structure HDS;
typedef typename Poly::Vertex Vertex;
typedef typename Poly::Halfedge Halfedge;
typedef typename Poly::Facet Facet;
@ -278,8 +271,6 @@ namespace Subdivision_method_3 {
typedef Polyhedron_decorator_3<Poly> PD;
typedef typename Poly::Halfedge_data_structure HDS;
typedef typename Poly::Vertex Vertex;
typedef typename Poly::Halfedge Halfedge;
typedef typename Poly::Facet Facet;
@ -288,7 +279,6 @@ namespace Subdivision_method_3 {
typedef typename Poly::Facet_handle Facet_handle;
typedef typename Poly::Vertex_iterator Vertex_iterator;
typedef typename Poly::Halfedge_iterator Halfedge_iterator;
typedef typename Poly::Edge_iterator Edge_iterator;
typedef typename Poly::Facet_iterator Facet_iterator;
@ -487,27 +477,16 @@ namespace Subdivision_method_3 {
template <class Poly, template <typename> class Mask>
void Sqrt3_1step(Poly& p, Mask<Poly> mask) {
typedef Polyhedron_decorator_3<Poly> PD;
typedef typename Poly::Halfedge_data_structure HDS;
typedef typename Poly::Vertex Vertex;
typedef typename Poly::Halfedge Halfedge;
typedef typename Poly::Facet Facet;
typedef typename Poly::Vertex_handle Vertex_handle;
typedef typename Poly::Halfedge_handle Halfedge_handle;
typedef typename Poly::Facet_handle Facet_handle;
typedef typename Poly::Vertex_iterator Vertex_iterator;
typedef typename Poly::Halfedge_iterator Halfedge_iterator;
typedef typename Poly::Edge_iterator Edge_iterator;
typedef typename Poly::Facet_iterator Facet_iterator;
typedef typename Poly::Halfedge_around_facet_circulator
Halfedge_around_facet_circulator;
typedef typename Poly::Halfedge_around_vertex_circulator
Halfedge_around_vertex_circulator;
typedef typename Poly::Traits Traits;
typedef typename Traits::Kernel Kernel;
typedef typename Kernel::Point_3 Point;

View File

@ -95,12 +95,8 @@ namespace Surface_mesher {
typedef typename Tr::Cell_handle Cell_handle;
typedef typename GT::Point_3 Point_3;
typedef typename GT::Triangle_3 Triangle_3;
typedef typename GT::Sphere_3 Sphere_3;
typedef typename GT::Ray_3 Ray_3;
typedef typename GT::Line_3 Line_3;
typedef typename GT::Vector_3 Vector_3;
typedef typename GT::FT FT;
typedef typename Surface_mesh_traits::Surface_3 Surface_3;
typedef typename Surface_mesh_traits::Intersection_point Intersection_point;
typename GT::Construct_midpoint_3 midpoint =

View File

@ -24,7 +24,6 @@ typename Kernel::Vector_3 compute_facet_normal(const Facet& f)
template <class Vertex, class Kernel>
typename Kernel::Vector_3 compute_vertex_normal(const Vertex& v)
{
typedef typename Kernel::Point_3 Point;
typedef typename Kernel::Vector_3 Vector;
typedef typename Vertex::Halfedge_around_vertex_const_circulator HV_circulator;
typedef typename Vertex::Facet Facet;

View File

@ -113,7 +113,6 @@ public:
typedef typename Tr::Geom_traits Geom_traits;
typedef typename Geom_traits::Compute_squared_radius_3 Radius;
typedef typename Geom_traits::Compute_squared_distance_3 Distance;
typedef typename Geom_traits::FT FT;
Radius radius = Geom_traits().compute_squared_radius_3_object();
Distance distance = Geom_traits().compute_squared_distance_3_object();

View File

@ -206,11 +206,6 @@ unsigned int poisson_refine_triangulation(
// Convergence is guaranteed if radius_edge_ratio_bound >= 1.0
CGAL_surface_reconstruction_points_precondition(radius_edge_ratio_bound >= 1.0);
// Basic geometric types
typedef typename Tr::Geom_traits Gt;
typedef typename Gt::FT FT;
typedef typename Gt::Point_3 Point;
// Mesher_level types
typedef Poisson_mesh_cell_criteria_3<Tr> Tets_criteria;
typedef typename CGAL::Surface_mesh_traits_generator_3<Surface>::type Oracle;

View File

@ -35,8 +35,6 @@ void apply_to_range(const Tr &t,
{
if (t.dimension()<2) return;
typedef typename Tr::Point POINT;
typedef typename Tr::Segment SEGMENT;
typedef typename Tr::Triangle TRIANGLE;
typedef typename Tr::Face_handle hFACE;
typedef typename Tr::Vertex_handle hVERTEX;
typedef typename Tr::Line_face_circulator LFC;

View File

@ -1385,18 +1385,10 @@ class Width_3 {
void width_3_convex(InputPolyhedron &P) {
DEBUGMSG(WIDTH_3_CONVEX,"\nBegin WIDTH_3_CONVEX");
typedef CGAL::Width_3_internal::Data_access<InputPolyhedron,Traits> DA;
typedef typename DA::Polyhedron Polyhedron;
typedef typename DA::Vertex Vertex;
typedef typename DA::Facet Facet;
typedef typename DA::Halfedge Halfedge;
typedef typename DA::Facet_handle Facet_handle;
typedef typename DA::Vertex_handle Vertex_handle;
typedef typename DA::Halfedge_handle Halfedge_handle;
typedef typename DA::PolyPoint PolyPoint;
typedef typename DA::Plane Plane;
typedef typename DA::Halfedge_iterator Halfedge_iterator;
typedef typename DA::Vertex_iterator Vertex_iterator;
typedef typename DA::Facet_iterator Facet_iterator;
//Ensure that Polyhedron has at least one vertex
CGAL_assertion_msg(P.size_of_vertices()>2,
"Can not compute width of a 0, 1 or 2-vertex polyhedron");