the VC++ testsuite should pass now

This commit is contained in:
Andreas Fabri 2016-01-03 17:48:00 +01:00 committed by Jane Tournois
parent a58847c97f
commit 54ec8f9d92
17 changed files with 38 additions and 44 deletions

View File

@ -22,6 +22,8 @@
#define CGAL_INTERNAL_LAZY_ALPHA_NT_3_H
#include <CGAL/assertions.h>
#include <CGAL/Cartesian_converter.h>
#include <CGAL/internal/Exact_type_selector.h>
#include <CGAL/Regular_triangulation_euclidean_traits_3.h>
#include <boost/shared_ptr.hpp>
#include <boost/type_traits.hpp>
@ -55,8 +57,8 @@ template <class Input_traits,class Kernel_input,class Kernel_approx,class Kernel
struct Types_for_alpha_nt_3< ::CGAL::Tag_true,Input_traits,Kernel_input,Kernel_approx,Kernel_exact>
{
//Converter types
typedef CGAL::Weighted_converter_3< CGAL::Cartesian_converter<Kernel_input,Kernel_approx> > To_approx;
typedef CGAL::Weighted_converter_3< CGAL::Cartesian_converter<Kernel_input,Kernel_exact> > To_exact;
typedef CGAL::Cartesian_converter<Kernel_input,Kernel_approx> To_approx;
typedef CGAL::Cartesian_converter<Kernel_input,Kernel_exact> To_exact;
//Traits types
typedef ::CGAL::Regular_triangulation_euclidean_traits_3<Kernel_approx> Approx_traits;
typedef ::CGAL::Regular_triangulation_euclidean_traits_3<Kernel_exact> Exact_traits;

View File

@ -20,7 +20,7 @@
typedef CGAL::Exact_predicates_inexact_constructions_kernel Kernel;
typedef CGAL::Regular_triangulation_euclidean_traits_3<Kernel> EPIC_traits;
typedef CGAL::Weighted_point<Kernel::Point_3,Kernel::FT> Weighted_point;
typedef CGAL::Weighted_point_3<Kernel> Weighted_point;
typedef CGAL::Fixed_alpha_shape_vertex_base_3<EPIC_traits> WFixed_Vb;
typedef CGAL::Fixed_alpha_shape_cell_base_3<EPIC_traits> WFixed_Cb;
typedef CGAL::Triangulation_data_structure_3<WFixed_Vb,WFixed_Cb> WFixed_TDS;

View File

@ -24,7 +24,7 @@ typedef WFixed_Gt
//typedef CGAL::Filtered_weighted_alpha_shape_euclidean_traits_3<Kernel,true> Gt;
typedef CGAL::Weighted_point<Kernel::Point_3,Kernel::FT> Weighted_point;
typedef CGAL::Weighted_point_3<Kernel> Weighted_point;
typedef CGAL::Fixed_alpha_shape_vertex_base_3<WFixed_Gt> WFixed_Vb;
typedef CGAL::Fixed_alpha_shape_cell_base_3<WFixed_Gt> WFixed_Cb;
typedef CGAL::Triangulation_data_structure_3<WFixed_Vb,WFixed_Cb> WFixed_TDS;

View File

@ -3130,11 +3130,12 @@ namespace HomogeneousKernelFunctors {
template <typename K>
class Construct_weighted_point_3
{
typedef typename K::RT RT;
typedef typename K::Point_3 Point_3;
typedef typename Point_3::Rep Rep;
typedef typename K::RT RT;
typedef typename K::Point_3 Point_3;
typedef typename K::Weighted_point_3 Weighted_point_3;
typedef typename Point_3::Rep Rep;
public:
typedef Weighted_point_3 result_type;
typedef Weighted_point_3 result_type;
Rep
operator()(Return_base_tag, const Point_3& p, const RT& w) const

View File

@ -54,6 +54,8 @@ public:
typedef typename R_::Vector_3 Vector_3;
typedef typename R_::Aff_transformation_3 Aff_transformation_3;
typedef Point_3 Point;
typedef RT Weight;
const Rep& rep() const
{

View File

@ -14,7 +14,7 @@ void extract_balls_from_pdb(const char *filename,
typedef ESBTL::Generic_classifier<ESBTL::Radius_of_atom<double,typename System::Atom> > T_Atom_classifier;
typedef ESBTL::Accept_none_occupancy_policy<ESBTL::PDB::Line_format<> > Accept_none_occupancy_policy;
typedef ESBTL::Weighted_atom_iterator<typename System::Model,
CGAL::Weighted_point<typename K::Point_3,double>,
typename K::Weighted_point_3,
ESBTL::Weight_of_atoms<T_Atom_classifier> > Weighted_atom_iterator;
ESBTL::PDB_line_selector sel;

View File

@ -4,7 +4,7 @@
typedef CGAL::Exact_predicates_inexact_constructions_kernel K;
typedef K::Point_3 Bare_point;
typedef CGAL::Weighted_point<Bare_point,K::RT> Weighted_point;
typedef K::Weighted_point_3 Weighted_point;
typedef CGAL::Polyhedron_3<K> Polyhedron;
int main() {

View File

@ -569,11 +569,11 @@ Skin_surface_quadratic_surface_3<Traits>
Skin_surface_base_3<MixedComplexTraits_3>::
construct_surface(const Simplex &sim, const Traits &) const {
typedef Skin_surface_quadratic_surface_3<Traits> Quadratic_surface;
typedef Weighted_converter_3<Cartesian_converter<
typename Geometric_traits::Bare_point::R, Traits> > Converter;
typedef Cartesian_converter<
typename Geometric_traits::Bare_point::R, Traits> Converter;
typedef typename Traits::Point_3 Point;
typedef typename Traits::FT FT;
typedef CGAL::Weighted_point<Point,FT> Weighted_point;
typedef typename Traits::Weighted_point_3 Weighted_point;
Converter conv;
@ -756,9 +756,8 @@ get_weighted_circumcenter(const Simplex &s, Gt2 &traits) {
Facet f;
Cell_handle ch;
Weighted_converter_3<
Cartesian_converter<typename Gt::Bare_point::R,
typename Gt2::Bare_point::R> > converter;
typename Gt2::Bare_point::R> converter;
typename Gt2::Bare_point result;
switch(s.dimension()) {

View File

@ -49,8 +49,8 @@ public:
typedef Filtered_predicate<
typename Exact_traits::Side_of_mixed_cell_3,
typename Filtering_traits::Side_of_mixed_cell_3,
Weighted_converter_3<C2E>,
Weighted_converter_3<C2F> > Side_of_mixed_cell_3;
C2E,
C2F > Side_of_mixed_cell_3;
enum { Has_filtered_predicates=true };
enum { Has_static_filters=false };

View File

@ -33,7 +33,7 @@ public:
typedef typename K::Point_3 Point;
typedef typename K::Vector_3 Vector;
typedef typename K::Segment_3 Segment;
typedef CGAL::Weighted_point<Point,FT> Weighted_point;
typedef typename K::Weighted_point_3 Weighted_point;
Skin_surface_quadratic_surface_3()
: dim(-1), p(0,0,0), c(0)
@ -63,7 +63,7 @@ public:
Regular_triangulation_euclidean_traits_3<K> reg_traits;
p = reg_traits.construct_weighted_circumcenter_3_object()(wp0,wp1);
c = s*(1-s)*reg_traits.compute_squared_radius_smallest_orthogonal_sphere_3_object()(wp0,wp1);
Vector t = wp0-wp1;
Vector t = reg_traits.construct_vector_3_object()(wp1,wp0);
FT den = t*t;
Q[0] = (- t.x()*t.x()/den + (1-s));

View File

@ -118,7 +118,7 @@ public:
typedef Weighted_point Weighted_point_3;
typedef CGAL::Side_of_mixed_cell_3<Self> Side_of_mixed_cell_3;
typedef CGAL::Construct_weighted_circumcenter_3<Self>
typedef typename Kernel::Construct_weighted_circumcenter_3
Construct_weighted_circumcenter_3;
typedef CGAL::Construct_anchor_point_3<Self> Construct_anchor_point_3;

View File

@ -72,11 +72,11 @@ public:
typedef Regular_triangulation_euclidean_traits_3<Surface_traits> Surface_regular_traits;
typedef typename Quadratic_surface::Point Surface_point;
typedef typename Quadratic_surface::Vector Surface_vector;
typedef Weighted_point<Surface_point,Surface_RT> Surface_weighted_point;
typedef typename Surface_traits::Weighted_point_3 Surface_weighted_point;
typedef Weighted_converter_3<
typedef
Cartesian_converter < typename Regular_traits::Bare_point::R,
typename Quadratic_surface::K > > R2S_converter;
typename Quadratic_surface::K > R2S_converter;
Triangulated_mixed_complex_observer_3(FT shrink) :
shrink(shrink) {}

View File

@ -253,22 +253,17 @@ private:
Triangulation_incremental_builder triangulation_incr_builder;
Construct_weighted_circumcenter_3<
Regular_triangulation_euclidean_traits_3<
Triangulated_mixed_complex_traits> > weighted_circumcenter_obj;
typename Tmc_traits::Construct_weighted_circumcenter_3 weighted_circumcenter_obj;
Weighted_converter_3<
Cartesian_converter<typename Regular_traits::Bare_point::R,
Triangulated_mixed_complex_traits > >
Cartesian_converter<typename Regular_traits::Bare_point::R,
Triangulated_mixed_complex_traits >
r2t_converter_object;
Construct_anchor_point_3<
Regular_triangulation_euclidean_traits_3<
Triangulated_mixed_complex_traits> > construct_anchor_point_3_obj;
Compute_squared_radius_smallest_orthogonal_sphere_3<
Regular_triangulation_euclidean_traits_3<
Triangulated_mixed_complex_traits> > orthoweight_obj;
typename Tmc_traits::Compute_squared_radius_smallest_orthogonal_sphere_3 orthoweight_obj;
Compute_anchor_3<Regular> compute_anchor_obj;
bool verbose;

View File

@ -200,19 +200,14 @@ private:
Triangulation_incremental_builder triangulation_incr_builder;
Construct_weighted_circumcenter_3<
Regular_triangulation_euclidean_traits_3<
Triangulated_mixed_complex_traits> > orthocenter_obj;
typename Tmc_traits::Construct_weighted_circumcenter_3 orthocenter_obj;
Compute_squared_radius_smallest_orthogonal_sphere_3<
Regular_triangulation_euclidean_traits_3<
Triangulated_mixed_complex_traits> > orthoweight_obj;
typename Tmc_traits::Compute_squared_radius_smallest_orthogonal_sphere_3 orthoweight_obj;
Compute_anchor_3<Regular> compute_anchor_obj;
bool verbose;
Weighted_converter_3<
Cartesian_converter<typename Regular_traits::Bare_point::R,
Triangulated_mixed_complex_traits > >
Triangulated_mixed_complex_traits >
r2t_converter_object;

View File

@ -15,7 +15,7 @@ int main(int, char *[]) {
{5.46575, 3.92853, 0.183865}};
typedef CGAL::Exact_predicates_inexact_constructions_kernel IKernel;
typedef IKernel::Point_3 Bare_point;
typedef CGAL::Weighted_point<Bare_point,IKernel::RT> Weighted_point;
typedef IKernel::Weighted_point_3 Weighted_point;
size_t size=sizeof(pts)/(3*sizeof(double));
std::vector<Weighted_point> l(size);
for (size_t i=0; i< size; ++i) {

View File

@ -15,7 +15,7 @@ int main(int, char *[]) {
{5.46575, 3.92853, 0.183865}};
typedef CGAL::Exact_predicates_exact_constructions_kernel Kernel;
typedef Kernel::Point_3 Bare_point;
typedef CGAL::Weighted_point<Bare_point,Kernel::RT> Weighted_point;
typedef Kernel::Weighted_point_3 Weighted_point;
size_t size=sizeof(pts)/(3*sizeof(double));
std::vector<Weighted_point> l(size);
for (size_t i=0; i< size; ++i) {

View File

@ -47,8 +47,8 @@ public:
typedef Bare_point result_type;
typedef Weighted_converter_3<Cartesian_converter<typename K::Kernel, EK2> > To_exact;
typedef Weighted_converter_3<Cartesian_converter<EK2, typename K::Kernel> > Back_from_exact;
typedef Cartesian_converter<typename K::Kernel, EK2> To_exact;
typedef Cartesian_converter<EK2, typename K::Kernel> Back_from_exact;
Bare_point operator() ( const Weighted_point_3 & p,