This application illustrates the AABB tree component
of CGAL, applied to polyhedron
facets and edges.
See also the following chapters of the manual:
diff --git a/Advancing_front_surface_reconstruction/include/CGAL/Advancing_front_surface_reconstruction.h b/Advancing_front_surface_reconstruction/include/CGAL/Advancing_front_surface_reconstruction.h
index 3e4d8ba7df9..c7f5e1325b2 100644
--- a/Advancing_front_surface_reconstruction/include/CGAL/Advancing_front_surface_reconstruction.h
+++ b/Advancing_front_surface_reconstruction/include/CGAL/Advancing_front_surface_reconstruction.h
@@ -370,19 +370,19 @@ namespace CGAL {
coord_type K, min_K;
const coord_type eps;
const coord_type inv_eps_2; // 1/(eps^2)
- const coord_type eps_3; // test de ^3 donc points tel 1e-7 soit petit
+ const coord_type eps_3; // tests using cubed eps so points such that 1e-7 is small
const criteria STANDBY_CANDIDATE;
const criteria STANDBY_CANDIDATE_BIS;
const criteria NOT_VALID_CANDIDATE;
//---------------------------------------------------------------------
- //Pour une visu correcte
- //pour retenir les facettes selectionnees
+ // For a correct visualization
+ // to retain the selected facets
int _vh_number;
int _facet_number;
//---------------------------------------------------------------------
- //Pour le post traitement
+ // For post-processing
mutable int _postprocessing_counter;
int _size_before_postprocessing;
@@ -501,9 +501,8 @@ namespace CGAL {
}
//-------------------------------------------------------------------
- // pour gerer certaines aretes interieures: a savoir celle encore connectee au
- // bord (en fait seule, les aretes interieures reliant 2 bords nous
- // interressent...)
+ // to handle certain interior edges, meaning those still connected to the boundary
+ // (actually, only the interior edges linking two boundaries are relevant)
inline void set_interior_edge(Vertex_handle w, Vertex_handle v)
{
@@ -806,7 +805,7 @@ namespace CGAL {
if ((number_of_facets() > static_cast(T.number_of_vertices()))&&
(NB_BORDER_MAX > 0))
- // en principe 2*nb_sommets = nb_facettes: y a encore de la marge!!!
+ // in theory 2*vertices_n = facets_n: plenty of room!!!
{
while(postprocessing()){
extend2_timer.start();
@@ -1068,9 +1067,8 @@ namespace CGAL {
//---------------------------------------------------------------------
bool is_interior_edge(const Edge_like& key) const
- // pour gerer certaines aretes interieures: a savoir celle encore connectee au
- // bord (en fait seule, les aretes interieures reliant 2 bords nous
- // interressent...)
+ // to handle certain interior edges, meaning those still connected to the boundary
+ // (actually, only the interior edges linking two boundaries are relevant)
{
return (is_interior_edge(key.first, key.second)||
is_interior_edge(key.second, key.first));
@@ -1299,7 +1297,6 @@ namespace CGAL {
#ifdef AFSR_LAZY
value = lazy_squared_radius(cc);
#else
- // qualified with CGAL, to avoid a compilation error with clang
if(volume(pp0, pp1, pp2, pp3) != 0){
value = T.geom_traits().compute_squared_radius_3_object()(pp0, pp1, pp2, pp3);
} else {
@@ -1337,7 +1334,6 @@ namespace CGAL {
{
value = compute_scalar_product(Vc, Vc) - ac*ac/norm_V;
if ((value < 0)||(norm_V > inv_eps_2)){
- // qualified with CGAL, to avoid a compilation error with clang
value = T.geom_traits().compute_squared_radius_3_object()(cp1, cp2, cp3);
}
}
@@ -1365,7 +1361,7 @@ namespace CGAL {
/// @}
//---------------------------------------------------------------------
- // For a border edge e we determine the incident facet which has the highest
+ // For a border edge e, we determine the incident facet which has the highest
// chance to be a natural extension of the surface
Radius_edge_type
@@ -1425,8 +1421,7 @@ namespace CGAL {
P2Pn = construct_vector(p2, pn);
v2 = construct_cross_product(P2P1,P2Pn);
- //pas necessaire de normer pour un bon echantillon:
- // on peut alors tester v1*v2 >= 0
+ // no need to normalize for a correct sampling: one can then test v1*v2 >= 0
norm = sqrt(norm1 * compute_scalar_product(v2,v2));
pscal = v1*v2;
// check if the triangle will produce a sliver on the surface
@@ -1437,7 +1432,8 @@ namespace CGAL {
if (tmp < min_valueA)
{
PnP1 = p1-pn;
- // DELTA represente la qualite d'echantillonnage du bord
+ // DELTA encodes the quality of the border sampling
+ //
// We skip triangles having an internal angle along e
// whose cosinus is smaller than -DELTA
// that is the angle is larger than arcos(-DELTA)
@@ -1462,37 +1458,36 @@ namespace CGAL {
if ((min_valueA == infinity()) || border_facet) // bad facets case
{
- min_facet = Facet(c, i); // !!! sans aucune signification....
- value = NOT_VALID_CANDIDATE; // Attention a ne pas inserer dans PQ
+ min_facet = Facet(c, i); // !!! without any meaning....
+ value = NOT_VALID_CANDIDATE; // Do not insert in the PQ
}
else
{
min_facet = min_facetA;
- //si on considere seulement la pliure value appartient a [0, 2]
- //value = coord_type(1) - min_valueP;
-
- // si la pliure est bonne on note suivant le alpha sinon on prend en compte la
- // pliure seule... pour discriminer entre les bons slivers...
- // si on veut discriminer les facettes de bonnes pliures plus finement
- // alors -(1+1/min_valueA) app a [-inf, -1]
- // -min_valueP app a [-1, 1]
+ // If we only consider the fold value belongs to [0, 2]
+ // value = coord_type(1) - min_valueP;
+ // If the fold is OK, we rate based on the alpha value. Otherwise, take only the fold into account
+ // to discriminate between good slivers.
+ //
+ // If we wish to discriminate the facets with good folds more finely,
+ // then:
+ // -(1+1/min_valueA) is within [-inf, -1]
+ // -min_valueP is within [-1, 1]
+ //
if (min_valueP > COS_BETA)
value = -(coord_type(1) + coord_type(1)/min_valueA);
else
{
- //on refuse une trop grande non-uniformite
+ // reject overly non-uniform values
coord_type tmp = priority (*this, c, i);
if (min_valueA <= K * tmp)
value = - min_valueP;
else
{
- value = STANDBY_CANDIDATE; // tres mauvais candidat mauvaise pliure
- // + grand alpha... a traiter plus tard....
- min_K =
- (std::min)(min_K,
- min_valueA/tmp);
+ value = STANDBY_CANDIDATE; // extremely bad candidate, bad fold + large alpha; handle later
+ min_K = (std::min)(min_K, min_valueA/tmp);
}
}
}
@@ -1597,7 +1592,7 @@ namespace CGAL {
}
//---------------------------------------------------------------------
- // test de reciprocite avant de recoller une oreille anti-singularite
+ // reciprocity test before glueing anti-singularity ear
int
test_merge(const Edge_like& ordered_key, const Border_elt& result,
const Vertex_handle& v, const coord_type& ear_alpha)
@@ -1622,12 +1617,12 @@ namespace CGAL {
coord_type norm = sqrt(compute_scalar_product(v1, v1) * compute_scalar_product(v2, v2));
if (v1*v2 > COS_BETA*norm)
- return 1; // label bonne pliure sinon:
+ return 1; // mark as good fold
if (ear_alpha <= K * priority(*this, neigh, n_ind))
- return 2; // label alpha coherent...
+ return 2; // mark alpha consistent
- return 0; //sinon oreille a rejeter...
+ return 0; // ear to be rejected
}
@@ -1753,7 +1748,7 @@ namespace CGAL {
Edge_like ordered_key(v1,v2);
if (!is_border_elt(ordered_key, result12))
- std::cerr << "+++probleme coherence bord " << std::endl;
+ std::cerr << "+++issue with border consistency " << std::endl;
bool is_border_el1 = is_border_elt(ordered_el1, result1),
is_border_el2 = is_border_elt(ordered_el2, result2);
@@ -1782,8 +1777,7 @@ namespace CGAL {
return FINAL_CASE;
}
//---------------------------------------------------------------------
- //on peut alors marquer v1 et on pourrait essayer de merger
- //sans faire de calcul inutile???
+ // we can then mark v1 and could try to merge without any useless computation???
if (is_border_el1)
{
Edge_incident_facet edge_Ifacet_2(Edge(c, i, edge_Efacet.first.third),
@@ -1796,7 +1790,7 @@ namespace CGAL {
return EAR_CASE;
}
//---------------------------------------------------------------------
- //idem pour v2
+ //idem for v2
if (is_border_el2)
{
Edge_incident_facet edge_Ifacet_1(Edge(c, i, edge_Efacet.first.second),
@@ -1852,9 +1846,9 @@ namespace CGAL {
// border incident to a point... _mark<1 even if th orientation
// may be such as one vh has 2 successorson the same border...
{
- // a ce niveau on peut tester si le recollement se fait en
- // maintenant la compatibilite d'orientation des bords (pour
- // surface orientable...) ou si elle est brisee...
+ // at this level, we can test if glueing can be done while keeping
+ // compatible orientations for the borders (for an orientable surface...)
+ // or if it is broken
Edge_incident_facet edge_Ifacet_1(Edge(c, i, edge_Efacet.first.second),
edge_Efacet.second);
Edge_incident_facet edge_Ifacet_2(Edge(c, i, edge_Efacet.first.third),
@@ -1884,8 +1878,8 @@ namespace CGAL {
Border_elt result_ear2;
Edge_like ear1_e, ear2_e;
- // pour maintenir la reconstruction d'une surface orientable :
- // on verifie que les bords se recollent dans des sens opposes
+ // to preserve the reconstruction of an orientable surface, we check that
+ // borders glue to one another in opposite directions
if (ordered_key.first==v1)
{
ear1_e = Edge_like(c->vertex(i), ear1_c ->vertex(ear1_i));
@@ -1897,7 +1891,7 @@ namespace CGAL {
ear2_e = Edge_like(c->vertex(i), ear2_c ->vertex(ear2_i));
}
- //maintient la surface orientable
+ // preserves orientability of the surface
bool is_border_ear1 = is_ordered_border_elt(ear1_e, result_ear1);
bool is_border_ear2 = is_ordered_border_elt(ear2_e, result_ear2);
bool ear1_valid(false), ear2_valid(false);
@@ -1931,8 +1925,7 @@ namespace CGAL {
{
Validation_case res = validate(ear1, e1.first);
if (!((res == EAR_CASE)||(res == FINAL_CASE)))
- std::cerr << "+++probleme de recollement : cas "
- << res << std::endl;
+ std::cerr << "+++issue in glueing: case " << res << std::endl;
e2 = compute_value(edge_Ifacet_2);
if (ordered_key.first == v1)
@@ -1948,8 +1941,7 @@ namespace CGAL {
{
Validation_case res = validate(ear2, e2.first);
if (!((res == EAR_CASE)||(res == FINAL_CASE)))
- std::cerr << "+++probleme de recollement : cas "
- << res << std::endl;
+ std::cerr << "+++issue in glueing : case " << res << std::endl;
e1 = compute_value(edge_Ifacet_1);
if (ordered_key.first == v1)
@@ -1962,25 +1954,23 @@ namespace CGAL {
_ordered_border.insert(Radius_ptr_type(e1.first, p1));
}
}
- else// les deux oreilles ne se recollent pas sur la meme arete...
+ else // both ears do not glue on the same edge
{
- // on resoud la singularite.
+ // resolve the singularity
if (ear1_valid)
{
Validation_case res = validate(ear1, e1.first);
if (!((res == EAR_CASE)||(res == FINAL_CASE)))
- std::cerr << "+++probleme de recollement : cas "
- << res << std::endl;
+ std::cerr << "+++issue in glueing: case " << res << std::endl;
}
if (ear2_valid)
{
Validation_case res = validate(ear2, e2.first);
if (!((res == EAR_CASE)||(res == FINAL_CASE)))
- std::cerr << "+++probleme de recollement : cas "
- << res << std::endl;
+ std::cerr << "+++issue in glueing : case " << res << std::endl;
}
- // on met a jour la PQ s'il y a lieu... mais surtout pas
- // avant la resolution de la singularite
+
+ // Update the PQ if needed, but not before resolving the singularity
if (!ear1_valid)
{
_ordered_border.insert(Radius_ptr_type(e1.first, p1));
@@ -2020,7 +2010,7 @@ namespace CGAL {
if (new_candidate.first == STANDBY_CANDIDATE)
{
- // a garder pour un K un peu plus grand...
+ // put aside for a slightly larger K
new_candidate.first = STANDBY_CANDIDATE_BIS;
}
@@ -2042,8 +2032,8 @@ namespace CGAL {
void
extend()
{
- // initilisation de la variable globale K: qualite d'echantillonnage requise
- K = K_init; // valeur d'initialisation de K pour commencer prudemment...
+ // Initialize the global variable K: required sampling quality
+ K = K_init; // initial value of K to start carefully
coord_type K_prev = K;
Vertex_handle v1, v2;
@@ -2052,7 +2042,7 @@ namespace CGAL {
}
do
{
- min_K = infinity(); // pour retenir le prochain K necessaire pour progresser...
+ min_K = infinity(); // to store the next K required to progress
do
{
@@ -2095,7 +2085,7 @@ namespace CGAL {
{
new_candidate = compute_value(mem_Ifacet);
if ((new_candidate != mem_e_it))
- // &&(new_candidate.first < NOT_VALID_CANDIDATE))
+ // &&(new_candidate.first < NOT_VALID_CANDIDATE))
{
IO_edge_type* pnew =
set_again_border_elt(key_tmp.first, key_tmp.second,
@@ -2111,8 +2101,7 @@ namespace CGAL {
(_ordered_border.begin()->first < STANDBY_CANDIDATE_BIS));
K_prev = K;
K += (std::max)(K_step, min_K - K + eps);
- // on augmente progressivement le K mais on a deja rempli sans
- // faire des betises auparavant...
+ // Progressively increase K, but having already filled without issue beforehand
}
while((!_ordered_border.empty())&&(K <= K)&&(min_K != infinity())&&(K!=K_prev));
@@ -2125,9 +2114,8 @@ namespace CGAL {
//---------------------------------------------------------------------
- // En principe, si l'allocateur de cellules etait bien fait on aurait pas besoin
- // de mettre a jour les valeurs rajoutees pour les cellules a la main...
-
+ // In theory, if the cell allocator were properly made, one would not need to manually update
+ // the values added for the cells
void
re_init_for_free_cells_cache(const Vertex_handle& vh)
{
@@ -2152,9 +2140,8 @@ namespace CGAL {
int index = c->index(vh);
Cell_handle neigh = c->neighbor(index);
int n_ind = neigh->index(c);
- neigh->set_smallest_radius(n_ind, -1); // pour obliger le recalcul
- // si c est selectionnee c'est qu'elle est aussi le mem_IFacet renvoye par
- // compute_value... donc a swapper aussi
+ neigh->set_smallest_radius(n_ind, -1); // forces recomputation
+ // if c is selected, then it is also the mem_IFacet returned by compute_value... so to be swapped too
if (c->is_selected_facet(index))
{
int fn = c->facet_number(index);
@@ -2214,8 +2201,8 @@ namespace CGAL {
circ = next(circ);
}
while(circ.first.first != c);
- // si on passe par la, alors y a eu un probleme....
- std::cerr << "+++probleme dans la MAJ avant remove..." << std::endl;
+ // if we are here, something went wrong
+ std::cerr << "+++issue in the update before removal..." << std::endl;
return Facet(c, start.second);
}
@@ -2237,7 +2224,7 @@ namespace CGAL {
ordered_map_erase(border_elt.second.first.first,
border_IO_elt(vh, vh_succ));
remove_border_edge(vh, vh_succ);
- // 1- a virer au cas ou car vh va etre detruit
+ // 1- remove just in case since vh is about to be destroyed
remove_interior_edge(vh_succ, vh);
bool while_cond(true);
do
@@ -2266,14 +2253,14 @@ namespace CGAL {
{
ordered_map_erase(result.first.first, border_IO_elt(vh_int, vh));
remove_border_edge(vh_int, vh);
- // 1- a virer au cas ou car vh va etre detruit
+ // 1- remove just in case since vh is about to be destroyed
remove_interior_edge(vh_int, vh);
while_cond = false;
}
- // a titre preventif... on essaye de s'assurer de marquer les aretes
- // interieures au sens large...
- // 2- a virer a tout pris pour que maintenir le sens de interior edge
+ // As a preventive measure, we try to ensure marking the interior edges in a broad sense
+
+ // 2- remove to preserve the interior edge
remove_interior_edge(vh_int, vh_succ);
remove_interior_edge(vh_succ, vh_int);
@@ -2304,16 +2291,16 @@ namespace CGAL {
bool
create_singularity(const Vertex_handle& vh)
{
- // Pour reperer le cas de triangle isole
+ // To detect the isolated triangle case
if (vh->is_on_border())
{
- // vh sommet 0
+ // vh vertex 0
Next_border_elt border_elt = *(vh->first_incident());
- Vertex_handle vh_1 = border_elt.first;// sommet 1
+ Vertex_handle vh_1 = border_elt.first;// vertex 1
border_elt = *(vh_1->first_incident());
- Vertex_handle vh_2 = border_elt.first;// sommet 2
+ Vertex_handle vh_2 = border_elt.first;// vertex 2
border_elt = *(vh_2->first_incident());
- Vertex_handle vh_3 = border_elt.first;// sommet 0 ???
+ Vertex_handle vh_3 = border_elt.first;// vertex 0 ???
Cell_handle c;
int i, j, k;
if ((vh_3 == vh)&&(T.is_facet(vh, vh_1, vh_2, c, i ,j ,k)))
@@ -2328,7 +2315,7 @@ namespace CGAL {
}
- // Reperer le cas d'aretes interieures...
+ // Detect the interior edges case
std::list vh_list;
T.incident_vertices(vh, std::back_inserter(vh_list));
@@ -2402,9 +2389,9 @@ namespace CGAL {
std::list L_v;
- // Pour controler les sommets choisis sur le bord...
+ // To control vertices chosen on the boundary
- // nombre d'aretes a partir duquel on considere que c'est irrecuperable NB_BORDER_MAX
+ // NB_BORDER_MAX: number of edges from which we consider that things are irrecoverable
int vh_on_border_inserted(0);
for(Finite_vertices_iterator v_it = T.finite_vertices_begin();
@@ -2445,7 +2432,7 @@ namespace CGAL {
std::size_t itmp, L_v_size_mem;
L_v_size_mem = L_v.size();
- if ((vh_on_border_inserted != 0)&& // pour ne post-traiter que les bords
+ if ((vh_on_border_inserted != 0)&& // to post-process only the borders
(L_v.size() < .1 * _size_before_postprocessing))
{
{
@@ -2460,7 +2447,7 @@ namespace CGAL {
}
#ifdef VERBOSE
if(L_v.size() > 0){
- std::cout << " " << L_v.size() << " non regular points." << std::endl;
+ std::cout << " " << L_v.size() << " non-regular points." << std::endl;
}
#endif // VERBOSE
re_compute_values();
@@ -2469,7 +2456,7 @@ namespace CGAL {
postprocess_timer.stop();
return false;
}
- // we stop if we removed more than 10% of points or after 20 rounds
+ // we stop if we removed more than 10% of points, or after 20 rounds
if ((L_v_size_mem == L_v.size())||
((_size_before_postprocessing - T.number_of_vertices()) >
.1 * _size_before_postprocessing)||
@@ -2479,7 +2466,6 @@ namespace CGAL {
}
min_K = infinity();
- // fin--
// if (_postprocessing_counter < 5)
// return true;
postprocess_timer.stop();
diff --git a/Advancing_front_surface_reconstruction/include/CGAL/Advancing_front_surface_reconstruction_vertex_base_3.h b/Advancing_front_surface_reconstruction/include/CGAL/Advancing_front_surface_reconstruction_vertex_base_3.h
index a8c2bf4b2b4..bbecac5c757 100644
--- a/Advancing_front_surface_reconstruction/include/CGAL/Advancing_front_surface_reconstruction_vertex_base_3.h
+++ b/Advancing_front_surface_reconstruction/include/CGAL/Advancing_front_surface_reconstruction_vertex_base_3.h
@@ -220,7 +220,7 @@ namespace CGAL {
else
{
if (m_incident_border->second->first != nullptr)
- std::cerr << "+++probleme de MAJ du bord " << std::endl;
+ std::cerr << "+++issue while updating border " << std::endl;
*m_incident_border->second = elt;
}
}
diff --git a/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Algebraic_curve_kernel_2.h b/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Algebraic_curve_kernel_2.h
index 9e2c0398fe2..d385b481a33 100644
--- a/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Algebraic_curve_kernel_2.h
+++ b/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Algebraic_curve_kernel_2.h
@@ -356,10 +356,10 @@ public:
const OuterFunctor& outer)
: _inner(inner), _outer(outer) {}
- Unary_compose(const Unary_compose& other)
- : _inner(other._inner), _outer(other._outer) {}
+ Unary_compose(const Unary_compose& other) = default;
+ Unary_compose& operator=(const Unary_compose& other) = default;
- Unary_compose() : _inner(::boost::none),_outer(::boost::none) {}
+ Unary_compose() : _inner(::boost::none),_outer(::boost::none) {}
typedef typename InnerFunctor::argument_type argument_type;
typedef typename OuterFunctor::result_type result_type;
diff --git a/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Algebraic_real_quadratic_refinement_rep_bfi.h b/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Algebraic_real_quadratic_refinement_rep_bfi.h
index 19f447c08f2..18b7fa805dd 100644
--- a/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Algebraic_real_quadratic_refinement_rep_bfi.h
+++ b/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Algebraic_real_quadratic_refinement_rep_bfi.h
@@ -45,7 +45,7 @@ namespace internal {
* @Unpublished{abbott-quadratic,
* author = {John Abbott},
* title = {Quadratic Interval Refinement for Real Roots},
- * url = {http://www.dima.unige.it/~abbott/},
+ * url = {https://www.dima.unige.it/~abbott/},
* note = {Poster presented at the 2006 Internat. Sympos. on Symbolic
and Algebraic Computation (ISSAC 2006)}
* }
diff --git a/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Bitstream_descartes.h b/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Bitstream_descartes.h
index f1f45aab56c..974e26d0a57 100644
--- a/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Bitstream_descartes.h
+++ b/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Bitstream_descartes.h
@@ -1147,8 +1147,8 @@ public:
Bitstream_descartes() : Base(new Rep()) {}
//! Copy constructor
- Bitstream_descartes(const Self& other) : Base(static_cast(other))
- {}
+ Bitstream_descartes(const Self& other) = default;
+ Bitstream_descartes& operator=(const Self& other) = default;
/*!
* \brief Constructor for a polynomial \c f
diff --git a/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Bitstream_descartes_E08_tree.h b/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Bitstream_descartes_E08_tree.h
index d78d50acfd0..50ae06acee9 100644
--- a/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Bitstream_descartes_E08_tree.h
+++ b/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Bitstream_descartes_E08_tree.h
@@ -436,6 +436,9 @@ public:
friend class CGAL::internal::Bitstream_descartes_E08_tree;
friend class CGAL::internal::Bitstream_descartes_E08_tree_rep;
+ Bitstream_descartes_E08_node(const Self&) = default;
+ Self& operator= (const Self&) = delete;
+
private:
// "node data" (set individually in subdivision)
Integer lower_num_, upper_num_; // TODO use lower_num_, width_num_ instead
@@ -466,8 +469,6 @@ private:
log_eps_ = n.log_eps_;
log_C_eps_ = n.log_C_eps_;
}
-
- Self& operator= (const Self&) = delete;
}; // struct Bitstream_descartes_E08_node
diff --git a/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Bitstream_descartes_rndl_tree.h b/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Bitstream_descartes_rndl_tree.h
index 869b758cb12..9d1084414cd 100644
--- a/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Bitstream_descartes_rndl_tree.h
+++ b/Algebraic_kernel_d/include/CGAL/Algebraic_kernel_d/Bitstream_descartes_rndl_tree.h
@@ -525,6 +525,9 @@ public:
friend class internal::Bitstream_descartes_rndl_tree;
friend class internal::Bitstream_descartes_rndl_tree_rep;
+ Bitstream_descartes_rndl_node(const Self&) = default;
+ Self& operator= (const Self&) = delete;
+
private:
// "node data" (set individually in subdivision)
Integer lower_num_, upper_num_; // TODO use lower_num_, width_num_ instead
@@ -557,8 +560,6 @@ private:
log_eps_ = n.log_eps_;
log_C_eps_ = n.log_C_eps_;
}
-
- Self& operator= (const Self&)=delete;
}; // struct Bitstream_descartes_rndl_node
diff --git a/Algebraic_kernel_d/test/Algebraic_kernel_d/include/CGAL/_test_real_root_isolator.h b/Algebraic_kernel_d/test/Algebraic_kernel_d/include/CGAL/_test_real_root_isolator.h
index b79e47262b3..ce3d7b3fda1 100644
--- a/Algebraic_kernel_d/test/Algebraic_kernel_d/include/CGAL/_test_real_root_isolator.h
+++ b/Algebraic_kernel_d/test/Algebraic_kernel_d/include/CGAL/_test_real_root_isolator.h
@@ -187,7 +187,7 @@ void test_real_root_isolator() {
assert( n == number_of_roots);
}{
//std::cout << "Kameny 3\n";
- // from http://www-sop.inria.fr/saga/POL/BASE/1.unipol
+ // from https://www-sop.inria.fr/saga/POL/BASE/1.unipol/
NT c = CGAL::ipower(NT(10),12);
Polynomial P(NT(-3),NT(0),c);
@@ -202,7 +202,7 @@ void test_real_root_isolator() {
assert(3 == internal::check_intervals_real_root_isolator(P));
}{
//std::cout << "Kameny 4\n";
- // from http://www-sop.inria.fr/saga/POL/BASE/1.unipol
+ // from https://www-sop.inria.fr/saga/POL/BASE/1.unipol
NT z(0);
NT a = CGAL::ipower(NT(10),24); // a = 10^{24}
@@ -218,7 +218,7 @@ void test_real_root_isolator() {
assert( 4 == internal::check_intervals_real_root_isolator(P));
}{
//std::cout << "Polynomial with large and small clustered roots\n";
- // from http://www-sop.inria.fr/saga/POL/BASE/1.unipol
+ // from https://www-sop.inria.fr/saga/POL/BASE/1.unipol
// there seems to be some error or misunderstanding
NT z(0);
diff --git a/Arrangement_on_surface_2/demo/Arrangement_on_surface_2/ColorItemEditor.cpp b/Arrangement_on_surface_2/demo/Arrangement_on_surface_2/ColorItemEditor.cpp
index 2de4a0d6e28..ee1772a644b 100644
--- a/Arrangement_on_surface_2/demo/Arrangement_on_surface_2/ColorItemEditor.cpp
+++ b/Arrangement_on_surface_2/demo/Arrangement_on_surface_2/ColorItemEditor.cpp
@@ -19,7 +19,7 @@
** Foundation and appearing in the file LICENSE.LGPL included in the
** packaging of this file. Please review the following information to
** ensure the GNU Lesser General Public License version 2.1 requirements
- ** will be met: http://www.gnu.org/licenses/old-licenses/lgpl-2.1.html.
+ ** will be met: https://www.gnu.org/licenses/old-licenses/lgpl-2.1.html.
**
** In addition, as a special exception, Nokia gives you certain additional
** rights. These rights are described in the Nokia Qt LGPL Exception
@@ -31,7 +31,7 @@
** Foundation and appearing in the file LICENSE.GPL included in the
** packaging of this file. Please review the following information to
** ensure the GNU General Public License version 3.0 requirements will be
- ** met: http://www.gnu.org/copyleft/gpl.html.
+ ** met: https://www.gnu.org/licenses/gpl-3.0.html.
**
** If you have questions regarding the use of this file, please contact
** Nokia at qt-info@nokia.com.
diff --git a/Arrangement_on_surface_2/demo/Arrangement_on_surface_2/ColorItemEditor.h b/Arrangement_on_surface_2/demo/Arrangement_on_surface_2/ColorItemEditor.h
index 13c6c13b06e..ea1a2ba7a47 100644
--- a/Arrangement_on_surface_2/demo/Arrangement_on_surface_2/ColorItemEditor.h
+++ b/Arrangement_on_surface_2/demo/Arrangement_on_surface_2/ColorItemEditor.h
@@ -19,7 +19,7 @@
** Foundation and appearing in the file LICENSE.LGPL included in the
** packaging of this file. Please review the following information to
** ensure the GNU Lesser General Public License version 2.1 requirements
- ** will be met: http://www.gnu.org/licenses/old-licenses/lgpl-2.1.html.
+ ** will be met: https://www.gnu.org/licenses/old-licenses/lgpl-2.1.html.
**
** In addition, as a special exception, Nokia gives you certain additional
** rights. These rights are described in the Nokia Qt LGPL Exception
@@ -31,7 +31,7 @@
** Foundation and appearing in the file LICENSE.GPL included in the
** packaging of this file. Please review the following information to
** ensure the GNU General Public License version 3.0 requirements will be
- ** met: http://www.gnu.org/copyleft/gpl.html.
+ ** met: https://www.gnu.org/licenses/gpl-3.0.html.
**
** If you have questions regarding the use of this file, please contact
** Nokia at qt-info@nokia.com.
diff --git a/Arrangement_on_surface_2/include/CGAL/Arr_point_location/Arr_trapezoid_ric_pl_impl.h b/Arrangement_on_surface_2/include/CGAL/Arr_point_location/Arr_trapezoid_ric_pl_impl.h
index f95817735da..5ad5f86b400 100644
--- a/Arrangement_on_surface_2/include/CGAL/Arr_point_location/Arr_trapezoid_ric_pl_impl.h
+++ b/Arrangement_on_surface_2/include/CGAL/Arr_point_location/Arr_trapezoid_ric_pl_impl.h
@@ -316,7 +316,7 @@ _vertical_ray_shoot(const Point_2& p, bool shoot_up) const
// face) we check the isolated vertices inside the face to check whether there
// is an isolated vertex right above/below the query point.
//
-template
+template
typename Arr_trapezoid_ric_point_location::result_type
Arr_trapezoid_ric_point_location::
_check_isolated_for_vertical_ray_shoot (Halfedge_const_handle halfedge_found,
@@ -324,40 +324,36 @@ _check_isolated_for_vertical_ray_shoot (Halfedge_const_handle halfedge_found,
bool shoot_up,
const Td_map_item& tr) const
{
+ const auto* gt = this->arrangement()->geometry_traits();
const Comparison_result point_above_under = (shoot_up ? SMALLER : LARGER);
- typename Geometry_traits_2::Compare_x_2 compare_x =
- this->arrangement()->traits()->compare_x_2_object();
- typename Geometry_traits_2::Compare_xy_2 compare_xy =
- this->arrangement()->traits()->compare_xy_2_object();
- typename Geometry_traits_2::Compare_y_at_x_2 compare_y_at_x =
- this->arrangement()->traits()->compare_y_at_x_2_object();
+ auto compare_x = gt->compare_x_2_object();
+ auto compare_xy = gt->compare_xy_2_object();
+ auto compare_y_at_x = gt->compare_y_at_x_2_object();
- Isolated_vertex_const_iterator iso_verts_it;
- Vertex_const_handle closest_iso_v;
- const Vertex_const_handle invalid_v;
- const Halfedge_const_handle invalid_he;
- Face_const_handle face;
+ Vertex_const_handle closest_iso_v;
+ const Vertex_const_handle invalid_v;
+ const Halfedge_const_handle invalid_he;
// If the closest feature is a valid halfedge, take its incident face.
// Otherwise, take the unbounded face.
- if (halfedge_found == invalid_he)
- face = _get_unbounded_face(tr, p, All_sides_oblivious_category());
- else
- face = halfedge_found->face();
+ Face_const_handle face = (halfedge_found == invalid_he) ?
+ _get_unbounded_face(tr, p, All_sides_oblivious_category()) :
+ halfedge_found->face();
// Go over the isolated vertices in the face.
+ // The following statement pacifies MSVC. Without it the implicit conversion
+ // from the iterator to the corresponding handle fails!
+ Isolated_vertex_const_iterator iso_verts_it;
for (iso_verts_it = face->isolated_vertices_begin();
iso_verts_it != face->isolated_vertices_end(); ++iso_verts_it)
{
// The current isolated vertex should have the same x-coordinate as the
// query point in order to be below or above it.
- if (compare_x (p, iso_verts_it->point()) != EQUAL)
- continue;
+ if (compare_x (p, iso_verts_it->point()) != EQUAL) continue;
// Make sure the isolated vertex is above the query point (if we shoot up)
// or below it (if we shoot down).
- if (compare_xy (p, iso_verts_it->point()) != point_above_under)
- continue;
+ if (compare_xy (p, iso_verts_it->point()) != point_above_under) continue;
// Check if the current isolated vertex lies closer to the query point than
// the closest feature so far.
@@ -379,12 +375,10 @@ _check_isolated_for_vertical_ray_shoot (Halfedge_const_handle halfedge_found,
// If we found an isolated vertex above (or under) the query point, return
// a handle to this vertex.
- if (closest_iso_v != invalid_v)
- return make_result(closest_iso_v);
+ if (closest_iso_v != invalid_v) return make_result(closest_iso_v);
// If we are inside the unbounded face, return this face.
- if (halfedge_found == invalid_he)
- return make_result(face);
+ if (halfedge_found == invalid_he) return make_result(face);
// Return the halfedge lying above (or below) the query point.
return make_result(halfedge_found);
diff --git a/Arrangement_on_surface_2/include/CGAL/Arr_polycurve_basic_traits_2.h b/Arrangement_on_surface_2/include/CGAL/Arr_polycurve_basic_traits_2.h
index ca5e8ce1447..dab9ffa9248 100644
--- a/Arrangement_on_surface_2/include/CGAL/Arr_polycurve_basic_traits_2.h
+++ b/Arrangement_on_surface_2/include/CGAL/Arr_polycurve_basic_traits_2.h
@@ -1114,7 +1114,7 @@ public:
// model of this concept.
//
// The following implementation is inspired by
- // http://stackoverflow.com/a/11816999/1915421
+ // https://stackoverflow.com/a/11816999/1915421
template
struct Void {
diff --git a/Arrangement_on_surface_2/include/CGAL/IO/Fig_stream.h b/Arrangement_on_surface_2/include/CGAL/IO/Fig_stream.h
index 0a89ec038a3..5fd87bc4e7b 100644
--- a/Arrangement_on_surface_2/include/CGAL/IO/Fig_stream.h
+++ b/Arrangement_on_surface_2/include/CGAL/IO/Fig_stream.h
@@ -164,7 +164,7 @@ enum Fig_depth
/*!
* \class A class for writing geometric objects in a FIG format (version 3.2).
- * For more details, see: http://www.xfig.org/userman/fig-format.html
+ * For more details, see: https://mcj.sourceforge.net/
*/
template
class Fig_stream
diff --git a/BGL/examples/BGL_LCC/normals_lcc.cpp b/BGL/examples/BGL_LCC/normals_lcc.cpp
index c5d1e671ff0..da1177a7062 100644
--- a/BGL/examples/BGL_LCC/normals_lcc.cpp
+++ b/BGL/examples/BGL_LCC/normals_lcc.cpp
@@ -74,7 +74,7 @@ int main(int argc, char** argv)
// Ad hoc property_map to store normals. Face_index_map is used to
// map face_descriptors to a contiguous range of indices. See
- // http://www.boost.org/libs/property_map/doc/vector_property_map.html
+ // https://www.boost.org/libs/property_map/doc/vector_property_map.html
// for details.
boost::vector_property_map
normals(static_cast(num_faces(lcc)), get(CGAL::face_index, lcc));
diff --git a/BGL/examples/BGL_polyhedron_3/normals.cpp b/BGL/examples/BGL_polyhedron_3/normals.cpp
index 9a67ba42b2d..711800cb8ab 100644
--- a/BGL/examples/BGL_polyhedron_3/normals.cpp
+++ b/BGL/examples/BGL_polyhedron_3/normals.cpp
@@ -79,7 +79,7 @@ int main(int argc, char** argv)
// Ad hoc property_map to store normals. Face_index_map is used to
// map face_descriptors to a contiguous range of indices. See
- // http://www.boost.org/libs/property_map/doc/vector_property_map.html
+ // https://www.boost.org/libs/property_map/doc/vector_property_map.html
// for details.
boost::vector_property_map
normals(static_cast(num_faces(P)), get(CGAL::face_index, P));
diff --git a/BGL/include/CGAL/boost/graph/graph_traits_PolyMesh_ArrayKernelT.h b/BGL/include/CGAL/boost/graph/graph_traits_PolyMesh_ArrayKernelT.h
index a6e5bfe287d..5127f692a24 100644
--- a/BGL/include/CGAL/boost/graph/graph_traits_PolyMesh_ArrayKernelT.h
+++ b/BGL/include/CGAL/boost/graph/graph_traits_PolyMesh_ArrayKernelT.h
@@ -11,7 +11,7 @@
#ifndef CGAL_BOOST_GRAPH_GRAPH_TRAITS_POLYMESH_ARRAYKERNELT_H
#define CGAL_BOOST_GRAPH_GRAPH_TRAITS_POLYMESH_ARRAYKERNELT_H
-// http://openmesh.org/Documentation/OpenMesh-Doc-Latest/classOpenMesh_1_1Concepts_1_1KernelT.html
+// https://www.graphics.rwth-aachen.de/media/openmesh_static/Documentations/OpenMesh-Doc-Latest/a02182.html
#include
#include
#include
diff --git a/BGL/include/CGAL/boost/graph/graph_traits_TriMesh_ArrayKernelT.h b/BGL/include/CGAL/boost/graph/graph_traits_TriMesh_ArrayKernelT.h
index 863dc50b075..512a4991e76 100644
--- a/BGL/include/CGAL/boost/graph/graph_traits_TriMesh_ArrayKernelT.h
+++ b/BGL/include/CGAL/boost/graph/graph_traits_TriMesh_ArrayKernelT.h
@@ -11,7 +11,7 @@
#ifndef CGAL_BOOST_GRAPH_GRAPH_TRAITS_TRIMESH_ARRAYKERNELT_H
#define CGAL_BOOST_GRAPH_GRAPH_TRAITS_TRIMESH_ARRAYKERNELT_H
-// http://openmesh.org/Documentation/OpenMesh-Doc-Latest/classOpenMesh_1_1Concepts_1_1KernelT.html
+// https://www.graphics.rwth-aachen.de/media/openmesh_static/Documentations/OpenMesh-Doc-Latest/a02182.html
#include
#include
#include
diff --git a/BGL/include/CGAL/boost/graph/named_params_helper.h b/BGL/include/CGAL/boost/graph/named_params_helper.h
index 303ab8c9ba1..b70872a7334 100644
--- a/BGL/include/CGAL/boost/graph/named_params_helper.h
+++ b/BGL/include/CGAL/boost/graph/named_params_helper.h
@@ -335,10 +335,10 @@ struct Point_set_processing_3_np_helper
return parameters::choose_parameter(parameters::get_parameter(np, internal_np::geom_traits));
}
- static constexpr bool has_normal_map()
+ static constexpr bool has_normal_map(const PointRange&, const NamedParameters&)
{
- return !std::is_same< typename internal_np::Get_param::type,
- internal_np::Param_not_found> ::value;
+ using CGAL::parameters::is_default_parameter;
+ return !(is_default_parameter::value);
}
};
diff --git a/BGL/include/CGAL/boost/graph/properties_OpenMesh.h b/BGL/include/CGAL/boost/graph/properties_OpenMesh.h
index 0740602e64f..861f5aea98b 100644
--- a/BGL/include/CGAL/boost/graph/properties_OpenMesh.h
+++ b/BGL/include/CGAL/boost/graph/properties_OpenMesh.h
@@ -130,16 +130,16 @@ public:
};
-template
+template
class OM_edge_weight_pmap
{
public:
typedef boost::readable_property_map_tag category;
- typedef typename OpenMesh::Scalar value_type;
+ typedef typename OM_Mesh::Scalar value_type;
typedef value_type reference;
- typedef typename boost::graph_traits::edge_descriptor key_type;
+ typedef typename boost::graph_traits::edge_descriptor key_type;
- OM_edge_weight_pmap(const OpenMesh& sm)
+ OM_edge_weight_pmap(const OM_Mesh& sm)
: sm_(sm)
{}
@@ -151,7 +151,7 @@ public:
friend inline value_type get(const OM_edge_weight_pmap& m, const key_type& k) { return m[k]; }
private:
- const OpenMesh& sm_;
+ const OM_Mesh& sm_;
};
template
@@ -175,26 +175,26 @@ public:
};
-template
+template
class OM_point_pmap
{
public:
#if defined(CGAL_USE_OM_POINTS)
typedef boost::lvalue_property_map_tag category;
- typedef typename OpenMesh::Point value_type;
- typedef const typename OpenMesh::Point& reference;
+ typedef typename OM_Mesh::Point value_type;
+ typedef const typename OM_Mesh::Point& reference;
#else
typedef boost::read_write_property_map_tag category;
typedef P value_type;
typedef P reference;
#endif
- typedef typename boost::graph_traits::vertex_descriptor key_type;
+ typedef typename boost::graph_traits::vertex_descriptor key_type;
OM_point_pmap()
: sm_(nullptr)
{}
- OM_point_pmap(const OpenMesh& sm)
+ OM_point_pmap(const OM_Mesh& sm)
: sm_(&sm)
{}
@@ -208,36 +208,37 @@ public:
return sm_->point(v);
#else
CGAL_assertion(sm_!=nullptr);
- typename OpenMesh::Point const& omp = sm_->point(v);
+ typename OM_Mesh::Point const& omp = sm_->point(v);
return value_type(omp[0], omp[1], omp[2]);
#endif
}
- inline friend reference get(const OM_point_pmap& pm, key_type v)
+ inline friend reference get(const OM_point_pmap& pm, key_type v)
{
CGAL_precondition(pm.sm_!=nullptr);
#if defined(CGAL_USE_OM_POINTS)
return pm.sm_->point(v);
#else
CGAL_assertion(pm.sm_!=nullptr);
- typename OpenMesh::Point const& omp = pm.sm_->point(v);
+ typename OM_Mesh::Point const& omp = pm.sm_->point(v);
return value_type(omp[0], omp[1], omp[2]);
#endif
}
- inline friend void put(const OM_point_pmap& pm, key_type v, const value_type& p)
+ inline friend void put(const OM_point_pmap& pm, key_type v, const value_type& p)
{
CGAL_precondition(pm.sm_!=nullptr);
#if defined(CGAL_USE_OM_POINTS)
- const_cast(*pm.sm_).set_point(v,p);
+ const_cast(*pm.sm_).set_point(v,p);
#else
- const_cast(*pm.sm_).set_point
- (v, typename OpenMesh::Point((float)p[0], (float)p[1], (float)p[2]));
+ typedef typename OpenMesh::vector_traits::value_type Scalar;
+ const_cast(*pm.sm_).set_point
+ (v, typename OM_Mesh::Point(Scalar(p[0]), Scalar(p[1]), Scalar(p[2])));
#endif
}
private:
- const OpenMesh* sm_;
+ const OM_Mesh* sm_;
};
} // CGAL
#endif // CGAL_BOOST_GRAPH_PROPERTIES_OPENMESH_H
diff --git a/BGL/include/CGAL/boost/graph/selection.h b/BGL/include/CGAL/boost/graph/selection.h
index b0ea97d89dd..46f36e27839 100644
--- a/BGL/include/CGAL/boost/graph/selection.h
+++ b/BGL/include/CGAL/boost/graph/selection.h
@@ -543,7 +543,7 @@ regularize_face_selection_borders(
(face_index_map));
for (mesh_face_descriptor fd : faces(mesh))
- put(is_selected, fd, graph.labels[get(face_index_map,fd)]);
+ put(is_selected, fd, (graph.labels[get(face_index_map,fd)] != 0));
}
/// \cond SKIP_IN_MANUAL
diff --git a/Barycentric_coordinates_2/examples/Barycentric_coordinates_2/CMakeLists.txt b/Barycentric_coordinates_2/examples/Barycentric_coordinates_2/CMakeLists.txt
index 547eb21203d..d5d5974e3b3 100644
--- a/Barycentric_coordinates_2/examples/Barycentric_coordinates_2/CMakeLists.txt
+++ b/Barycentric_coordinates_2/examples/Barycentric_coordinates_2/CMakeLists.txt
@@ -1,10 +1,10 @@
# Created by the script cgal_create_cmake_script.
# This is the CMake script for compiling a CGAL application.
-project(Barycentric_coordinates_2_Examples)
-
cmake_minimum_required(VERSION 3.1...3.23)
+project(Barycentric_coordinates_2_Examples)
+
find_package(CGAL REQUIRED COMPONENTS Core)
create_single_source_cgal_program("segment_coordinates.cpp")
diff --git a/Barycentric_coordinates_2/include/CGAL/Barycentric_coordinates_2/Harmonic_coordinates_2.h b/Barycentric_coordinates_2/include/CGAL/Barycentric_coordinates_2/Harmonic_coordinates_2.h
index 8e7efbd5fc3..164861dc6aa 100644
--- a/Barycentric_coordinates_2/include/CGAL/Barycentric_coordinates_2/Harmonic_coordinates_2.h
+++ b/Barycentric_coordinates_2/include/CGAL/Barycentric_coordinates_2/Harmonic_coordinates_2.h
@@ -587,8 +587,7 @@ namespace Barycentric_coordinates {
const auto& p0 = m_domain.vertex(neighbors[jm]);
const auto& p1 = m_domain.vertex(neighbors[j]);
const auto& p2 = m_domain.vertex(neighbors[jp]);
- const FT w = -Weights::cotangent_weight(
- p0, p1, p2, query, m_traits) / FT(2);
+ const FT w = -Weights::cotangent_weight(p0, p1, p2, query, m_traits) / FT(2);
W -= w;
if (m_domain.is_on_boundary(idx)) {
diff --git a/Barycentric_coordinates_2/test/Barycentric_coordinates_2/CMakeLists.txt b/Barycentric_coordinates_2/test/Barycentric_coordinates_2/CMakeLists.txt
index 8dfd74dd75c..8884394ec83 100644
--- a/Barycentric_coordinates_2/test/Barycentric_coordinates_2/CMakeLists.txt
+++ b/Barycentric_coordinates_2/test/Barycentric_coordinates_2/CMakeLists.txt
@@ -1,10 +1,10 @@
# Created by the script cgal_create_cmake_script.
# This is the CMake script for compiling a CGAL application.
-project(Barycentric_coordinates_2_Tests)
-
cmake_minimum_required(VERSION 3.1...3.23)
+project(Barycentric_coordinates_2_Tests)
+
find_package(CGAL REQUIRED COMPONENTS Core)
create_single_source_cgal_program("test_almost_degenerate_segment.cpp")
diff --git a/Boolean_set_operations_2/include/CGAL/Polygon_set_2.h b/Boolean_set_operations_2/include/CGAL/Polygon_set_2.h
index d986acfd860..d1c2305c2dd 100644
--- a/Boolean_set_operations_2/include/CGAL/Polygon_set_2.h
+++ b/Boolean_set_operations_2/include/CGAL/Polygon_set_2.h
@@ -58,7 +58,7 @@ public:
{}
/*! Constructor with traits object. */
- Polygon_set_2 (Traits_2& tr) :
+ Polygon_set_2 (const Traits_2& tr) :
Base(tr)
{}
diff --git a/Bounding_volumes/include/CGAL/Min_sphere_of_spheres_d/Min_sphere_of_spheres_d_pair.h b/Bounding_volumes/include/CGAL/Min_sphere_of_spheres_d/Min_sphere_of_spheres_d_pair.h
index c3dcc29c393..e30576790c5 100644
--- a/Bounding_volumes/include/CGAL/Min_sphere_of_spheres_d/Min_sphere_of_spheres_d_pair.h
+++ b/Bounding_volumes/include/CGAL/Min_sphere_of_spheres_d/Min_sphere_of_spheres_d_pair.h
@@ -42,7 +42,7 @@ namespace CGAL_MINIBALL_NAMESPACE {
{
// That constant is embedded in an inline static function, to
// workaround a bug of g++>=4.1
- // http://gcc.gnu.org/bugzilla/show_bug.cgi?id=36912
+ // https://gcc.gnu.org/bugzilla/show_bug.cgi?id=36912
// g++ does not like const floating expression when -frounding-math
// is used.
static double result() {
@@ -55,7 +55,7 @@ namespace CGAL_MINIBALL_NAMESPACE {
{
// That constant is embedded in an inline static function, to
// workaround a bug of g++>=4.1
- // http://gcc.gnu.org/bugzilla/show_bug.cgi?id=36912
+ // https://gcc.gnu.org/bugzilla/show_bug.cgi?id=36912
// g++ does not like const floating expression when -frounding-math
// is used.
static float result() {
@@ -68,7 +68,7 @@ namespace CGAL_MINIBALL_NAMESPACE {
{
// That constant is embedded in an inline static function, to
// workaround a bug of g++>=4.1
- // http://gcc.gnu.org/bugzilla/show_bug.cgi?id=36912
+ // https://gcc.gnu.org/bugzilla/show_bug.cgi?id=36912
// g++ does not like const floating expression when -frounding-math
// is used.
static double result() {
@@ -81,7 +81,7 @@ namespace CGAL_MINIBALL_NAMESPACE {
{
// That constant is embedded in an inline static function, to
// workaround a bug of g++>=4.1
- // http://gcc.gnu.org/bugzilla/show_bug.cgi?id=36912
+ // https://gcc.gnu.org/bugzilla/show_bug.cgi?id=36912
// g++ does not like const floating expression when -frounding-math
// is used.
static float result() {
diff --git a/CGAL_Core/include/CGAL/CORE/BigFloat.h b/CGAL_Core/include/CGAL/CORE/BigFloat.h
index 97183f63e50..6c7a8abff4c 100644
--- a/CGAL_Core/include/CGAL/CORE/BigFloat.h
+++ b/CGAL_Core/include/CGAL/CORE/BigFloat.h
@@ -14,7 +14,7 @@
* Chen Li
* Zilin Du
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/BigFloatRep.h b/CGAL_Core/include/CGAL/CORE/BigFloatRep.h
index 7439ce025a9..da8cb6967c8 100644
--- a/CGAL_Core/include/CGAL/CORE/BigFloatRep.h
+++ b/CGAL_Core/include/CGAL/CORE/BigFloatRep.h
@@ -14,7 +14,7 @@
* Chen Li
* Zilin Du
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/BigFloat_impl.h b/CGAL_Core/include/CGAL/CORE/BigFloat_impl.h
index aa029b5c51b..dc828ae9379 100644
--- a/CGAL_Core/include/CGAL/CORE/BigFloat_impl.h
+++ b/CGAL_Core/include/CGAL/CORE/BigFloat_impl.h
@@ -23,7 +23,7 @@
* Chen Li
* Zilin Du
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/BigInt.h b/CGAL_Core/include/CGAL/CORE/BigInt.h
index 7b16a960ac3..f88a5877c9b 100644
--- a/CGAL_Core/include/CGAL/CORE/BigInt.h
+++ b/CGAL_Core/include/CGAL/CORE/BigInt.h
@@ -14,7 +14,7 @@
* Chen Li
* Zilin Du
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/BigRat.h b/CGAL_Core/include/CGAL/CORE/BigRat.h
index 29b99509d40..d57e4e44cd9 100644
--- a/CGAL_Core/include/CGAL/CORE/BigRat.h
+++ b/CGAL_Core/include/CGAL/CORE/BigRat.h
@@ -14,7 +14,7 @@
* Chen Li
* Zilin Du
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/CORE.h b/CGAL_Core/include/CGAL/CORE/CORE.h
index 3fb78af5f83..a3e0b2ef83d 100644
--- a/CGAL_Core/include/CGAL/CORE/CORE.h
+++ b/CGAL_Core/include/CGAL/CORE/CORE.h
@@ -15,7 +15,7 @@
* Chen Li
* Zilin Du
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/CoreAux.h b/CGAL_Core/include/CGAL/CORE/CoreAux.h
index 9d75668be3a..fdb6c5de7cf 100644
--- a/CGAL_Core/include/CGAL/CORE/CoreAux.h
+++ b/CGAL_Core/include/CGAL/CORE/CoreAux.h
@@ -14,7 +14,7 @@
* Chen Li
* Zilin Du
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/CoreAux_impl.h b/CGAL_Core/include/CGAL/CORE/CoreAux_impl.h
index 3f22a4cdfa1..9b335c393b2 100644
--- a/CGAL_Core/include/CGAL/CORE/CoreAux_impl.h
+++ b/CGAL_Core/include/CGAL/CORE/CoreAux_impl.h
@@ -15,7 +15,7 @@
* Chen Li
* Zilin Du
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/CoreDefs.h b/CGAL_Core/include/CGAL/CORE/CoreDefs.h
index 57c3da34645..e10ea21ec1a 100644
--- a/CGAL_Core/include/CGAL/CORE/CoreDefs.h
+++ b/CGAL_Core/include/CGAL/CORE/CoreDefs.h
@@ -17,7 +17,7 @@
* Chen Li
* Zilin Du
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/CoreDefs_impl.h b/CGAL_Core/include/CGAL/CORE/CoreDefs_impl.h
index d28326496f3..ecc29261130 100644
--- a/CGAL_Core/include/CGAL/CORE/CoreDefs_impl.h
+++ b/CGAL_Core/include/CGAL/CORE/CoreDefs_impl.h
@@ -14,7 +14,7 @@
* Chen Li
* Zilin Du
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/CoreIO_impl.h b/CGAL_Core/include/CGAL/CORE/CoreIO_impl.h
index 0e4a2044e74..59f4a7a63f6 100644
--- a/CGAL_Core/include/CGAL/CORE/CoreIO_impl.h
+++ b/CGAL_Core/include/CGAL/CORE/CoreIO_impl.h
@@ -11,7 +11,7 @@
* Zilin Du
* Chee Yap
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/Expr.h b/CGAL_Core/include/CGAL/CORE/Expr.h
index 5cd5092d7e9..94b086e24d3 100644
--- a/CGAL_Core/include/CGAL/CORE/Expr.h
+++ b/CGAL_Core/include/CGAL/CORE/Expr.h
@@ -18,7 +18,7 @@
* Sylvain Pion
* Vikram Sharma
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/ExprRep.h b/CGAL_Core/include/CGAL/CORE/ExprRep.h
index 7920485fff7..bc142c77b6c 100644
--- a/CGAL_Core/include/CGAL/CORE/ExprRep.h
+++ b/CGAL_Core/include/CGAL/CORE/ExprRep.h
@@ -18,7 +18,7 @@
* Sylvain Pion
* Vikram Sharma
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/Expr_impl.h b/CGAL_Core/include/CGAL/CORE/Expr_impl.h
index 5e3806024fa..69ccc73b616 100644
--- a/CGAL_Core/include/CGAL/CORE/Expr_impl.h
+++ b/CGAL_Core/include/CGAL/CORE/Expr_impl.h
@@ -16,7 +16,7 @@
* Zilin Du
* Sylvain Pion
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/Filter.h b/CGAL_Core/include/CGAL/CORE/Filter.h
index ea0a02da1fa..56649b80c86 100644
--- a/CGAL_Core/include/CGAL/CORE/Filter.h
+++ b/CGAL_Core/include/CGAL/CORE/Filter.h
@@ -17,7 +17,7 @@
* Zilin Du
* Chee Yap
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/MemoryPool.h b/CGAL_Core/include/CGAL/CORE/MemoryPool.h
index 606b9223b2b..60a95c862e2 100644
--- a/CGAL_Core/include/CGAL/CORE/MemoryPool.h
+++ b/CGAL_Core/include/CGAL/CORE/MemoryPool.h
@@ -14,7 +14,7 @@
* Chee Yap
* Sylvain Pion
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/Promote.h b/CGAL_Core/include/CGAL/CORE/Promote.h
index 62a98e434ef..d882b6abcf3 100644
--- a/CGAL_Core/include/CGAL/CORE/Promote.h
+++ b/CGAL_Core/include/CGAL/CORE/Promote.h
@@ -18,7 +18,7 @@
* Sylvain Pion
* Vikram Sharma
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/Real.h b/CGAL_Core/include/CGAL/CORE/Real.h
index b79503eb4c2..11174960dd2 100644
--- a/CGAL_Core/include/CGAL/CORE/Real.h
+++ b/CGAL_Core/include/CGAL/CORE/Real.h
@@ -18,7 +18,7 @@
* Zilin Du
* Sylvain Pion
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/RealRep.h b/CGAL_Core/include/CGAL/CORE/RealRep.h
index 5a18d2748d1..85f7818a884 100644
--- a/CGAL_Core/include/CGAL/CORE/RealRep.h
+++ b/CGAL_Core/include/CGAL/CORE/RealRep.h
@@ -16,7 +16,7 @@
* Zilin Du
* Sylvain Pion
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/Real_impl.h b/CGAL_Core/include/CGAL/CORE/Real_impl.h
index 8a6a4899c64..e7ac7379f4c 100644
--- a/CGAL_Core/include/CGAL/CORE/Real_impl.h
+++ b/CGAL_Core/include/CGAL/CORE/Real_impl.h
@@ -17,7 +17,7 @@
* Zilin Du
* Sylvain Pion
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/RefCount.h b/CGAL_Core/include/CGAL/CORE/RefCount.h
index 91fafbf074f..ba1c8416a4b 100644
--- a/CGAL_Core/include/CGAL/CORE/RefCount.h
+++ b/CGAL_Core/include/CGAL/CORE/RefCount.h
@@ -35,7 +35,7 @@
* Zilin Du
* Chee Yap
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/Timer.h b/CGAL_Core/include/CGAL/CORE/Timer.h
index a0f2ce9f152..0e998c0b020 100644
--- a/CGAL_Core/include/CGAL/CORE/Timer.h
+++ b/CGAL_Core/include/CGAL/CORE/Timer.h
@@ -23,7 +23,7 @@
* Written by
* Zilin Du
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/extLong.h b/CGAL_Core/include/CGAL/CORE/extLong.h
index d20caf05589..52ba91e321a 100644
--- a/CGAL_Core/include/CGAL/CORE/extLong.h
+++ b/CGAL_Core/include/CGAL/CORE/extLong.h
@@ -17,7 +17,7 @@
* Chen Li
* Zilin Du
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/extLong_impl.h b/CGAL_Core/include/CGAL/CORE/extLong_impl.h
index 0baeb58fbcd..69d92131839 100644
--- a/CGAL_Core/include/CGAL/CORE/extLong_impl.h
+++ b/CGAL_Core/include/CGAL/CORE/extLong_impl.h
@@ -21,7 +21,7 @@
* Zilin Du
* Sylvain Pion
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/linearAlgebra.h b/CGAL_Core/include/CGAL/CORE/linearAlgebra.h
index 16da34e461a..3d760cc629b 100644
--- a/CGAL_Core/include/CGAL/CORE/linearAlgebra.h
+++ b/CGAL_Core/include/CGAL/CORE/linearAlgebra.h
@@ -22,7 +22,7 @@
* Written by
* Shubin Zhao (shubinz@cs.nyu.edu) (2001)
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $Id$
diff --git a/CGAL_Core/include/CGAL/CORE/poly/Curves.h b/CGAL_Core/include/CGAL/CORE/poly/Curves.h
index 65d1422d255..f1c9172e3e9 100644
--- a/CGAL_Core/include/CGAL/CORE/poly/Curves.h
+++ b/CGAL_Core/include/CGAL/CORE/poly/Curves.h
@@ -49,7 +49,7 @@
* Author: Vikram Sharma and Chee Yap
* Date: April 12, 2004
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/poly/Curves.tcc b/CGAL_Core/include/CGAL/CORE/poly/Curves.tcc
index d9be84796c0..f21ddfec3a8 100644
--- a/CGAL_Core/include/CGAL/CORE/poly/Curves.tcc
+++ b/CGAL_Core/include/CGAL/CORE/poly/Curves.tcc
@@ -16,7 +16,7 @@
* Author: Vikram Sharma and Chee Yap
* Date: April 12, 2004
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/poly/Poly.h b/CGAL_Core/include/CGAL/CORE/poly/Poly.h
index bd56376a5b2..50ec728b685 100644
--- a/CGAL_Core/include/CGAL/CORE/poly/Poly.h
+++ b/CGAL_Core/include/CGAL/CORE/poly/Poly.h
@@ -36,7 +36,7 @@
* Author: Chee Yap
* Date: May 28, 2002
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/poly/Poly.tcc b/CGAL_Core/include/CGAL/CORE/poly/Poly.tcc
index 325f64d528c..604a86ad6e1 100644
--- a/CGAL_Core/include/CGAL/CORE/poly/Poly.tcc
+++ b/CGAL_Core/include/CGAL/CORE/poly/Poly.tcc
@@ -30,7 +30,7 @@
* Author: Chee Yap, Sylvain Pion and Vikram Sharma
* Date: May 28, 2002
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/CORE/poly/Sturm.h b/CGAL_Core/include/CGAL/CORE/poly/Sturm.h
index 57fe5b26b7f..77ceab8c9ae 100644
--- a/CGAL_Core/include/CGAL/CORE/poly/Sturm.h
+++ b/CGAL_Core/include/CGAL/CORE/poly/Sturm.h
@@ -37,7 +37,7 @@
* Author: Chee Yap and Sylvain Pion, Vikram Sharma
* Date: July 20, 2002
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_Core/include/CGAL/export/CORE.h b/CGAL_Core/include/CGAL/export/CORE.h
index 440239528a1..651387e610d 100644
--- a/CGAL_Core/include/CGAL/export/CORE.h
+++ b/CGAL_Core/include/CGAL/export/CORE.h
@@ -18,7 +18,7 @@
* Sylvain Pion
* Vikram Sharma
*
- * WWW URL: http://cs.nyu.edu/exact/
+ * WWW URL: https://cs.nyu.edu/exact/
* Email: exact@cs.nyu.edu
*
* $URL$
diff --git a/CGAL_ImageIO/include/CGAL/ImageIO.h b/CGAL_ImageIO/include/CGAL/ImageIO.h
index 9c6b4281cc6..26ada2cfd76 100644
--- a/CGAL_ImageIO/include/CGAL/ImageIO.h
+++ b/CGAL_ImageIO/include/CGAL/ImageIO.h
@@ -24,7 +24,7 @@
#ifdef CGAL_USE_ZLIB
#include
-/* see http://www.gzip.org/zlib/
+/* see https://zlib.net/
for details and documentation
*/
#endif
@@ -342,8 +342,8 @@ CGAL_IMAGEIO_EXPORT _image *_createImage(std::size_t x, std::size_t y, std::size
GIS (CEA, IRISA, ENST 3D image format).
See also:
- http://www.dcs.ed.ac.uk/home/mxr/gfx/2d-hi.html and
- http://www.gzip.org/zlib/
+ https://www.martinreddy.net/gfx/2d-hi.html and
+ https://zlib.net/
@param name image file name or nullptr for stdin */
diff --git a/CGAL_ImageIO/include/CGAL/ImageIO/convert.h b/CGAL_ImageIO/include/CGAL/ImageIO/convert.h
index 4cb73637c49..0119d73736d 100644
--- a/CGAL_ImageIO/include/CGAL/ImageIO/convert.h
+++ b/CGAL_ImageIO/include/CGAL/ImageIO/convert.h
@@ -19,7 +19,7 @@
*
* AUTHOR:
* Gregoire Malandain (greg@sophia.inria.fr)
- * http://www.inria.fr/epidaure/personnel/malandain/
+ * https://www-sop.inria.fr/members/Gregoire.Malandain/
*
* CREATION DATE:
* June, 9 1998
diff --git a/CGAL_ImageIO/include/CGAL/ImageIO/recbuffer.h b/CGAL_ImageIO/include/CGAL/ImageIO/recbuffer.h
index 4fba58fb19b..9e35ebd637b 100644
--- a/CGAL_ImageIO/include/CGAL/ImageIO/recbuffer.h
+++ b/CGAL_ImageIO/include/CGAL/ImageIO/recbuffer.h
@@ -23,7 +23,7 @@
*
* AUTHOR:
* Gregoire Malandain (greg@sophia.inria.fr)
- * http://www.inria.fr/epidaure/personnel/malandain/
+ * https://www-sop.inria.fr/members/Gregoire.Malandain/
*
* CREATION DATE:
* June, 9 1998
diff --git a/CGAL_ImageIO/include/CGAL/ImageIO/recline.h b/CGAL_ImageIO/include/CGAL/ImageIO/recline.h
index b8ae7b398a3..588bd8d6434 100644
--- a/CGAL_ImageIO/include/CGAL/ImageIO/recline.h
+++ b/CGAL_ImageIO/include/CGAL/ImageIO/recline.h
@@ -23,7 +23,7 @@
*
* AUTHOR:
* Gregoire Malandain (greg@sophia.inria.fr)
- * http://www.inria.fr/epidaure/personnel/malandain/
+ * https://www-sop.inria.fr/members/Gregoire.Malandain/
*
* CREATION DATE:
* June, 9 1998
diff --git a/CGAL_ImageIO/include/CGAL/ImageIO/typedefs.h b/CGAL_ImageIO/include/CGAL/ImageIO/typedefs.h
index c4c612cc6e3..a77de031f64 100644
--- a/CGAL_ImageIO/include/CGAL/ImageIO/typedefs.h
+++ b/CGAL_ImageIO/include/CGAL/ImageIO/typedefs.h
@@ -19,7 +19,7 @@
*
* AUTHOR:
* Gregoire Malandain (greg@sophia.inria.fr)
- * http://www.inria.fr/epidaure/personnel/malandain/
+ * https://www-sop.inria.fr/members/Gregoire.Malandain/
*
* CREATION DATE:
* June, 9 1998
diff --git a/CGAL_ipelets/doc/CGAL_ipelets/CGAL_ipelets.txt b/CGAL_ipelets/doc/CGAL_ipelets/CGAL_ipelets.txt
index e5c3467650f..922e4e8f9bd 100644
--- a/CGAL_ipelets/doc/CGAL_ipelets/CGAL_ipelets.txt
+++ b/CGAL_ipelets/doc/CGAL_ipelets/CGAL_ipelets.txt
@@ -9,7 +9,7 @@ namespace CGAL {
\section CGAL_ipeletsIntroduction Introduction
-The Ipe extensible drawing editor (http://ipe.otfried.org) \cgalCite{schwarzkopf1995ede}, \cgalCite{ipe:man-09}
+The Ipe extensible drawing editor (https://ipe.otfried.org/) \cgalCite{schwarzkopf1995ede}, \cgalCite{ipe:man-09}
is a tool used by computational geometry researchers to produce 2D figures for inclusion in articles or presentations.
The extensible adjective sheds a light on an important feature:
the possibility for users to write small extensions (called ipelets)
diff --git a/Cartesian_kernel/include/CGAL/Cartesian/function_objects.h b/Cartesian_kernel/include/CGAL/Cartesian/function_objects.h
index a93004ad293..737a52dfc14 100644
--- a/Cartesian_kernel/include/CGAL/Cartesian/function_objects.h
+++ b/Cartesian_kernel/include/CGAL/Cartesian/function_objects.h
@@ -17,6 +17,7 @@
#ifndef CGAL_CARTESIAN_FUNCTION_OBJECTS_H
#define CGAL_CARTESIAN_FUNCTION_OBJECTS_H
+#include
#include
#include
#include
@@ -445,14 +446,14 @@ namespace CartesianKernelFunctors {
}
template
- result_type
+ Needs_FT
operator()(const T1& p, const T2& q, const T3& r) const
{
return CGAL::compare(squared_distance(p, q), squared_distance(p, r));
}
template
- result_type
+ Needs_FT
operator()(const T1& p, const T2& q, const T3& r, const T4& s) const
{
return CGAL::compare(squared_distance(p, q), squared_distance(r, s));
@@ -591,14 +592,14 @@ namespace CartesianKernelFunctors {
}
template
- result_type
+ Needs_FT
operator()(const T1& p, const T2& q, const T3& r) const
{
return CGAL::compare(squared_distance(p, q), squared_distance(p, r));
}
template
- result_type
+ Needs_FT
operator()(const T1& p, const T2& q, const T3& r, const T4& s) const
{
return CGAL::compare(squared_distance(p, q), squared_distance(r, s));
@@ -668,28 +669,34 @@ namespace CartesianKernelFunctors {
result_type
operator()(const Point_3& p, const Point_3& q, const Point_3& r, const Point_3& s, const FT& ft) const
{
- return CGAL::compare(squared_radiusC3(p.x(), p.y(), p.z(),
- q.x(), q.y(), q.z(),
- r.x(), r.y(), r.z(),
- s.x(), s.y(), s.z() ),
- ft);
+ FT num, den;
+ squared_radiusC3(p.x(), p.y(), p.z(),
+ q.x(), q.y(), q.z(),
+ r.x(), r.y(), r.z(),
+ s.x(), s.y(), s.z(),
+ num, den);
+ return CGAL::compare(num, den * ft);
}
result_type
operator()(const Point_3& p, const Point_3& q, const Point_3& r, const FT& ft) const
{
- return CGAL::compare(squared_radiusC3(p.x(), p.y(), p.z(),
- q.x(), q.y(), q.z(),
- r.x(), r.y(), r.z()),
- ft);
+ FT num, den;
+ squared_radiusC3(p.x(), p.y(), p.z(),
+ q.x(), q.y(), q.z(),
+ r.x(), r.y(), r.z(),
+ num, den);
+ return CGAL::compare(num, den * ft);
}
result_type
operator()(const Point_3& p, const Point_3& q, const FT& ft) const
{
- return CGAL::compare(squared_radiusC3(p.x(), p.y(), p.z(),
- q.x(), q.y(), q.z() ),
- ft);
+ FT num, den;
+ squared_radiusC3(p.x(), p.y(), p.z(),
+ q.x(), q.y(), q.z(),
+ num, den);
+ return CGAL::compare(num, den * ft);
}
result_type
@@ -1234,26 +1241,35 @@ namespace CartesianKernelFunctors {
result_type
operator()( const Point_3& p, const Point_3& q) const
{
- return squared_radiusC3(p.x(), p.y(), p.z(),
- q.x(), q.y(), q.z());
+ FT num, den;
+ squared_radiusC3(p.x(), p.y(), p.z(),
+ q.x(), q.y(), q.z(),
+ num, den);
+ return num / den;
}
result_type
operator()( const Point_3& p, const Point_3& q, const Point_3& r) const
{
- return squared_radiusC3(p.x(), p.y(), p.z(),
- q.x(), q.y(), q.z(),
- r.x(), r.y(), r.z());
+ FT num, den;
+ squared_radiusC3(p.x(), p.y(), p.z(),
+ q.x(), q.y(), q.z(),
+ r.x(), r.y(), r.z(),
+ num, den);
+ return num / den;
}
result_type
operator()( const Point_3& p, const Point_3& q,
const Point_3& r, const Point_3& s) const
{
- return squared_radiusC3(p.x(), p.y(), p.z(),
- q.x(), q.y(), q.z(),
- r.x(), r.y(), r.z(),
- s.x(), s.y(), s.z());
+ FT num, den;
+ squared_radiusC3(p.x(), p.y(), p.z(),
+ q.x(), q.y(), q.z(),
+ r.x(), r.y(), r.z(),
+ s.x(), s.y(), s.z(),
+ num, den);
+ return num / den;
}
};
@@ -2505,7 +2521,7 @@ namespace CartesianKernelFunctors {
FT rsy = psz*qsx-psx*qsz;
FT rsz = psx*qsy-psy*qsx;
- // The following determinants can be developped and simplified.
+ // The following determinants can be developed and simplified.
//
// FT num_x = determinant(psy,psz,ps2,
// qsy,qsz,qs2,
@@ -3961,7 +3977,7 @@ namespace CartesianKernelFunctors {
operator()(const Circle_3 &a, const Point_3 &p) const
{ return a.rep().has_on(p); }
- result_type
+ Needs_FT
operator()(const Sphere_3 &a, const Circle_3 &p) const
{ return a.rep().has_on(p); }
@@ -4205,8 +4221,7 @@ namespace CartesianKernelFunctors {
public:
typedef typename K::Orientation result_type;
- result_type
- operator()(const Point_2& p, const Point_2& q, const Point_2& r) const
+ result_type operator()(const Point_2& p, const Point_2& q, const Point_2& r) const
{
return orientationC2(p.x(), p.y(), q.x(), q.y(), r.x(), r.y());
}
diff --git a/Cartesian_kernel/include/CGAL/constructions/kernel_ftC3.h b/Cartesian_kernel/include/CGAL/constructions/kernel_ftC3.h
index 77fe5d05e7c..dbc973138c5 100644
--- a/Cartesian_kernel/include/CGAL/constructions/kernel_ftC3.h
+++ b/Cartesian_kernel/include/CGAL/constructions/kernel_ftC3.h
@@ -142,11 +142,12 @@ centroidC3( const FT &px, const FT &py, const FT &pz,
template < class FT >
CGAL_KERNEL_MEDIUM_INLINE
-FT
+void
squared_radiusC3(const FT &px, const FT &py, const FT &pz,
- const FT &qx, const FT &qy, const FT &qz,
- const FT &rx, const FT &ry, const FT &rz,
- const FT &sx, const FT &sy, const FT &sz)
+ const FT &qx, const FT &qy, const FT &qz,
+ const FT &rx, const FT &ry, const FT &rz,
+ const FT &sx, const FT &sy, const FT &sz,
+ FT &num, FT &den)
{
// Translate p to origin to simplify the expression.
FT qpx = qx-px;
@@ -163,29 +164,30 @@ squared_radiusC3(const FT &px, const FT &py, const FT &pz,
FT sp2 = CGAL_NTS square(spx) + CGAL_NTS square(spy) + CGAL_NTS square(spz);
FT num_x = determinant(qpy,qpz,qp2,
- rpy,rpz,rp2,
- spy,spz,sp2);
+ rpy,rpz,rp2,
+ spy,spz,sp2);
FT num_y = determinant(qpx,qpz,qp2,
- rpx,rpz,rp2,
- spx,spz,sp2);
+ rpx,rpz,rp2,
+ spx,spz,sp2);
FT num_z = determinant(qpx,qpy,qp2,
- rpx,rpy,rp2,
- spx,spy,sp2);
- FT den = determinant(qpx,qpy,qpz,
- rpx,rpy,rpz,
- spx,spy,spz);
- CGAL_kernel_assertion( ! CGAL_NTS is_zero(den) );
+ rpx,rpy,rp2,
+ spx,spy,sp2);
+ FT dden = determinant(qpx,qpy,qpz,
+ rpx,rpy,rpz,
+ spx,spy,spz);
+ CGAL_kernel_assertion( ! CGAL_NTS is_zero(dden) );
- return (CGAL_NTS square(num_x) + CGAL_NTS square(num_y)
- + CGAL_NTS square(num_z)) / CGAL_NTS square(2 * den);
+ num = CGAL_NTS square(num_x) + CGAL_NTS square(num_y) + CGAL_NTS square(num_z);
+ den = CGAL_NTS square(2 * dden);
}
template < class FT >
CGAL_KERNEL_MEDIUM_INLINE
-FT
+void
squared_radiusC3(const FT &px, const FT &py, const FT &pz,
- const FT &qx, const FT &qy, const FT &qz,
- const FT &sx, const FT &sy, const FT &sz)
+ const FT &qx, const FT &qy, const FT &qz,
+ const FT &sx, const FT &sy, const FT &sz,
+ FT &num, FT &den)
{
// Translate s to origin to simplify the expression.
FT psx = px-sx;
@@ -207,14 +209,14 @@ squared_radiusC3(const FT &px, const FT &py, const FT &pz,
FT num_z = ps2 * determinant(qsx,qsy,rsx,rsy)
- qs2 * determinant(psx,psy,rsx,rsy);
- FT den = determinant(psx,psy,psz,
- qsx,qsy,qsz,
- rsx,rsy,rsz);
+ FT dden = determinant(psx,psy,psz,
+ qsx,qsy,qsz,
+ rsx,rsy,rsz);
- CGAL_kernel_assertion( den != 0 );
+ CGAL_kernel_assertion( dden != 0 );
- return (CGAL_NTS square(num_x) + CGAL_NTS square(num_y)
- + CGAL_NTS square(num_z)) / CGAL_NTS square(2 * den);
+ num = CGAL_NTS square(num_x) + CGAL_NTS square(num_y) + CGAL_NTS square(num_z);
+ den = CGAL_NTS square(2 * dden);
}
template
@@ -305,11 +307,13 @@ squared_distanceC3( const FT &px, const FT &py, const FT &pz,
template < class FT >
CGAL_KERNEL_INLINE
-FT
+void
squared_radiusC3( const FT &px, const FT &py, const FT &pz,
- const FT &qx, const FT &qy, const FT &qz)
+ const FT &qx, const FT &qy, const FT &qz,
+ FT &num, FT &den)
{
- return squared_distanceC3(px, py, pz, qx, qy, qz) / 4;
+ num = squared_distanceC3(px, py, pz, qx, qy, qz);
+ den = FT(4);
}
template < class FT >
diff --git a/Cartesian_kernel/include/CGAL/predicates/kernel_ftC3.h b/Cartesian_kernel/include/CGAL/predicates/kernel_ftC3.h
index 8765d0cb587..0bb67083388 100644
--- a/Cartesian_kernel/include/CGAL/predicates/kernel_ftC3.h
+++ b/Cartesian_kernel/include/CGAL/predicates/kernel_ftC3.h
@@ -754,7 +754,7 @@ power_side_of_bounded_power_sphereC3(
}
// return the sign of the power test of weighted point (rx,ry,rz,rw)
- // with respect to the smallest sphere orthogoanal to
+ // with respect to the smallest sphere orthogonal to
// p,q
template< class FT >
typename Same_uncertainty_nt::type
@@ -764,20 +764,19 @@ power_side_of_bounded_power_sphereC3(
const FT &rx, const FT &ry, const FT &rz, const FT &rw)
{
FT FT2(2);
- FT FT4(4);
FT dpx = px - qx;
FT dpy = py - qy;
FT dpz = pz - qz;
FT dpw = pw - qw;
FT dp2 = CGAL_NTS square(dpx) + CGAL_NTS square(dpy) + CGAL_NTS square(dpz);
- FT drx = rx - (px + qx)/FT2;
- FT dry = ry - (py + qy)/FT2;
- FT drz = rz - (pz + qz)/FT2;
- FT drw = rw - (pw + qw)/FT2;
+ FT drx = FT2 * rx - (px + qx);
+ FT dry = FT2 * ry - (py + qy);
+ FT drz = FT2 * rz - (pz + qz);
+ FT drw = FT2 * rw - (pw + qw);
FT dr2 = CGAL_NTS square(drx) + CGAL_NTS square(dry) + CGAL_NTS square(drz);
FT dpr = dpx*drx + dpy*dry +dpz*drz;
return enum_cast(
- - CGAL_NTS sign (dr2 - dp2/FT4 + dpr*dpw/dp2 - drw ));
+ - CGAL_NTS sign (dr2*dp2 - dp2*dp2 + FT2*dpr*dpw - FT2*drw*dp2 ));
}
} // namespace CGAL
diff --git a/Circular_kernel_2/doc/Circular_kernel_2/Circular_kernel_2.txt b/Circular_kernel_2/doc/Circular_kernel_2/Circular_kernel_2.txt
index 41a5e7b9db4..740788d9b14 100644
--- a/Circular_kernel_2/doc/Circular_kernel_2/Circular_kernel_2.txt
+++ b/Circular_kernel_2/doc/Circular_kernel_2/Circular_kernel_2.txt
@@ -90,7 +90,7 @@ also added more functionality in 2008.
This work was partially supported by the IST Programme of the EU as a
Shared-cost RTD (FET Open) Project under Contract No IST-2000-26473
-(ECG - Effective
+(ECG - Effective
Computational Geometry for Curves and Surfaces) and by the IST
Programme of the 6th Framework Programme of the EU as a STREP (FET
Open Scheme) Project under Contract No IST-006413
diff --git a/Circular_kernel_2/include/CGAL/IO/Dxf_reader.h b/Circular_kernel_2/include/CGAL/IO/Dxf_reader.h
index bf00857272b..a66bd69bf63 100644
--- a/Circular_kernel_2/include/CGAL/IO/Dxf_reader.h
+++ b/Circular_kernel_2/include/CGAL/IO/Dxf_reader.h
@@ -16,7 +16,7 @@
// (ACS -- Algorithms for Complex Shapes)
// Description of the file format can be found at the following address:
-// http://www.autodesk.com/techpubs/autocad/acad2000/dxf/
+// https://images.autodesk.com/adsk/files/autocad_2012_pdf_dxf-reference_enu.pdf
#ifndef CGAL_IO_DXF_READER_H
#define CGAL_IO_DXF_READER_H
diff --git a/Circular_kernel_2/include/CGAL/IO/Dxf_reader_doubles.h b/Circular_kernel_2/include/CGAL/IO/Dxf_reader_doubles.h
index 4da1adc4c96..900dd9aed87 100644
--- a/Circular_kernel_2/include/CGAL/IO/Dxf_reader_doubles.h
+++ b/Circular_kernel_2/include/CGAL/IO/Dxf_reader_doubles.h
@@ -16,8 +16,7 @@
// (ACS -- Algorithms for Complex Shapes)
// Descriptions of the file format can be found at
-// http://www.autodesk.com/techpubs/autocad/acad2000/dxf/
-// http://www.tnt.uni-hannover.de/soft/compgraph/fileformats/docs/DXF.ascii
+// https://images.autodesk.com/adsk/files/autocad_2012_pdf_dxf-reference_enu.pdf
#ifndef CGAL_IO_DXF_READER_DOUBLES_H
#define CGAL_IO_DXF_READER_DOUBLES_H
diff --git a/Circular_kernel_2/include/CGAL/IO/Dxf_variant_reader.h b/Circular_kernel_2/include/CGAL/IO/Dxf_variant_reader.h
index 84672c295f7..d0ace79c85c 100644
--- a/Circular_kernel_2/include/CGAL/IO/Dxf_variant_reader.h
+++ b/Circular_kernel_2/include/CGAL/IO/Dxf_variant_reader.h
@@ -17,7 +17,7 @@
// (ACS -- Algorithms for Complex Shapes)
// Description of the file format can be found at the following address:
-// http://www.autodesk.com/techpubs/autocad/acad2000/dxf/
+// https://images.autodesk.com/adsk/files/autocad_2012_pdf_dxf-reference_enu.pdf
#ifndef CGAL_IO_DXF_VARIANT_READER_H
#define CGAL_IO_DXF_VARIANT_READER_H
diff --git a/Classification/doc/Classification/Classification.txt b/Classification/doc/Classification/Classification.txt
index 2c4c11eee49..10157e274ff 100644
--- a/Classification/doc/Classification/Classification.txt
+++ b/Classification/doc/Classification/Classification.txt
@@ -528,7 +528,10 @@ The following example:
\section Classification_history History
-This package is based on a research code by [Florent Lafarge](https://www-sop.inria.fr/members/Florent.Lafarge/) that was generalized, extended and packaged by [Simon Giraudot](http://geometryfactory.com/who-we-are/) in \cgal 4.12. %Classification of surface meshes and of clusters were introduced in \cgal 4.13. The Neural Network classifier was introduced in \cgal 4.14.
+This package is based on a research code by [Florent Lafarge](https://www-sop.inria.fr/members/Florent.Lafarge/)
+that was generalized, extended and packaged by [Simon Giraudot](https://geometryfactory.com/who-we-are/)
+in \cgal 4.12. %Classification of surface meshes and of clusters were introduced in \cgal 4.13.
+The Neural Network classifier was introduced in \cgal 4.14.
diff --git a/Combinatorial_map/doc/Combinatorial_map/Combinatorial_map.txt b/Combinatorial_map/doc/Combinatorial_map/Combinatorial_map.txt
index 58ada384336..423f49aae1c 100644
--- a/Combinatorial_map/doc/Combinatorial_map/Combinatorial_map.txt
+++ b/Combinatorial_map/doc/Combinatorial_map/Combinatorial_map.txt
@@ -542,7 +542,7 @@ Let d0\f$ \in \f$ D be a dart. Given i, 1 \f$ \leq \f$ i
\section Combinatorial_mapDesign Design and Implementation History
-The code of this package is inspired by Moka, a 3D topological modeler mainly developed by Frédéric Vidil and Guillaume Damiand (http://moka-modeller.sourceforge.net/). However, Moka was based on Generalized maps (and not Combinatorial maps), and the design was not \cgal "compatible". Thus, Guillaume Damiand started to develop a totally new package by mixing ideas taken from Moka with the design of the Halfedge data structure package of \cgal. Andreas Fabri and Sébastien Loriot contributed to the design, the coding, and to the documentation of the package, and Laurent Rineau helped for the design. Emma Michel contributed to the manual. Monique Teillaud and Bernd Gärtner contributed to the manual by giving useful remarks, really numerous and detailed for Monique. Ken Arroyo Ohori contributed to the two reverse orientation functions.
+The code of this package is inspired by Moka, a 3D topological modeler mainly developed by Frédéric Vidil and Guillaume Damiand (https://moka-modeller.sourceforge.net/). However, Moka was based on Generalized maps (and not Combinatorial maps), and the design was not \cgal "compatible". Thus, Guillaume Damiand started to develop a totally new package by mixing ideas taken from Moka with the design of the Halfedge data structure package of \cgal. Andreas Fabri and Sébastien Loriot contributed to the design, the coding, and to the documentation of the package, and Laurent Rineau helped for the design. Emma Michel contributed to the manual. Monique Teillaud and Bernd Gärtner contributed to the manual by giving useful remarks, really numerous and detailed for Monique. Ken Arroyo Ohori contributed to the two reverse orientation functions.
*/
} /* namespace CGAL */
diff --git a/Combinatorial_map/include/CGAL/Compact_container_with_index.h b/Combinatorial_map/include/CGAL/Compact_container_with_index.h
index 37d555793b6..a87122500fc 100644
--- a/Combinatorial_map/include/CGAL/Compact_container_with_index.h
+++ b/Combinatorial_map/include/CGAL/Compact_container_with_index.h
@@ -752,9 +752,12 @@ public:
return false;
}
- bool owns_dereferencable(const_iterator cit) const
+ bool owns_dereferenceable(const_iterator cit) const
{ return cit!=end() && owns(cit); }
+ CGAL_DEPRECATED bool owns_dereferencable(const_iterator cit) const
+ { return owns_dereferenceable(cit); }
+
/** Reserve method to ensure that the capacity of the Compact_container be
* greater or equal than a given value n.
*/
diff --git a/Documentation/doc/Documentation/Developer_manual/Chapter_checks.txt b/Documentation/doc/Documentation/Developer_manual/Chapter_checks.txt
index 73cd228cf95..0583952c360 100644
--- a/Documentation/doc/Documentation/Developer_manual/Chapter_checks.txt
+++ b/Documentation/doc/Documentation/Developer_manual/Chapter_checks.txt
@@ -185,7 +185,7 @@ MSVC][msvc-assume], or [`__builtin_unreachable`][builtin-unreachable]
recognized by both clang and g++.
[msvc-assume]: https://msdn.microsoft.com/en-us/library/1b3fsfxw.aspx
-[builtin-unreachable]: http://clang.llvm.org/docs/LanguageExtensions.html#builtin-unreachable
+[builtin-unreachable]: https://clang.llvm.org/docs/LanguageExtensions.html#builtin-unreachable
\section secexception_handling Exception handling
@@ -193,7 +193,7 @@ Some parts of the library use exceptions, but there is no general specific
policy concerning exception handling in \cgal. It is nevertheless good to
target exception safety, as much as possible. Good references on exception
safety are: Appendix E of \cgalCite{cgal:s-cpl-97} (also available at
-http://www.stroustrup.com/3rd_safe0.html),
+https://www.stroustrup.com/3rd_safe0.html),
and \cgalCite{cgal:a-esgc-98} (also available at
https://www.boost.org/community/exception_safety.html).
Any destructor which might throw an exception, including a destructor which
diff --git a/Documentation/doc/Documentation/Developer_manual/Chapter_iterators_and_circulators.txt b/Documentation/doc/Documentation/Developer_manual/Chapter_iterators_and_circulators.txt
index b7450d5cd3d..bb7567c4858 100644
--- a/Documentation/doc/Documentation/Developer_manual/Chapter_iterators_and_circulators.txt
+++ b/Documentation/doc/Documentation/Developer_manual/Chapter_iterators_and_circulators.txt
@@ -42,7 +42,7 @@ Thus we will not give a full description of these concept here
but only a few hints about how to use and write handle, iterators and circulators in \cgal. Developers should consult the above-mentioned references to become
familiar with the iterator, circulator and handle concepts. In
particular, the notions of iterator and circulator ranges,
-dereferencable and past-the-end values,
+dereferenceable and past-the-end values,
mutable and constant iterators and circulators,
and the different categories (forward, bidirectional, random-access, etc.)
of iterators and circulators, are fundamental.
diff --git a/Documentation/doc/Documentation/License.txt b/Documentation/doc/Documentation/License.txt
index cb272b4180f..1eaf49026dd 100644
--- a/Documentation/doc/Documentation/License.txt
+++ b/Documentation/doc/Documentation/License.txt
@@ -19,7 +19,7 @@ based on GPLed \cgal data structures, obliges you to distribute the
source code of your software under the GPL.
The exact license terms can be found at the Free Software Foundation
-web site: http://www.gnu.org/copyleft/gpl.html.
+web site: https://www.gnu.org/licenses/gpl-3.0.html.
\section licensesLGPL GNU LGPL
@@ -29,7 +29,7 @@ In contrast to the GPL, there is no obligation to distribute the source
code of software you build on top of LGPLed \cgal data structures.
The exact license terms can be found at the Free Software Foundation web site:
-http://www.gnu.org/copyleft/lesser.html.
+https://www.gnu.org/licenses/lgpl-3.0.html.
\section licensesRationale Rationale of the License Choice
@@ -46,7 +46,7 @@ The package overview states for each package under which license it is distribut
Users who cannot comply with the Open Source license terms can buy individual
data structures under various commercial licenses from GeometryFactory:
-http://www.geometryfactory.com/. License fees paid by commercial
+https://www.geometryfactory.com/. License fees paid by commercial
customers are reinvested in R\&D performed by the \cgal project partners,
as well as in evolutive maintenance.
diff --git a/Documentation/doc/Documentation/Third_party.txt b/Documentation/doc/Documentation/Third_party.txt
index d74dcdaf7b9..b981472df6a 100644
--- a/Documentation/doc/Documentation/Third_party.txt
+++ b/Documentation/doc/Documentation/Third_party.txt
@@ -11,11 +11,11 @@ supporting C++14 or later.
| Operating System | Compiler |
| :---------- | :--------------- |
-| Linux | \gnu `g++` 10.2.1 or later\cgalFootnote{\cgalFootnoteCode{http://gcc.gnu.org/}} |
-| | `Clang` \cgalFootnote{\cgalFootnoteCode{http://clang.llvm.org/}} compiler version 13.0.1 |
-| \ms Windows | \gnu `g++` 10.2.1 or later\cgalFootnote{\cgalFootnoteCode{http://gcc.gnu.org/}} |
+| Linux | \gnu `g++` 10.2.1 or later\cgalFootnote{\cgalFootnoteCode{https://gcc.gnu.org/}} |
+| | `Clang` \cgalFootnote{\cgalFootnoteCode{https://clang.llvm.org/}} compiler version 13.0.1 |
+| \ms Windows | \gnu `g++` 10.2.1 or later\cgalFootnote{\cgalFootnoteCode{https://gcc.gnu.org/}} |
| | \ms Visual `C++` 14.0, 15.9, 16.10, 17.0 (\visualstudio 2015, 2017, 2019, and 2022)\cgalFootnote{\cgalFootnoteCode{https://visualstudio.microsoft.com/}} |
-| MacOS X | \gnu `g++` 10.2.1 or later\cgalFootnote{\cgalFootnoteCode{http://gcc.gnu.org/}} |
+| MacOS X | \gnu `g++` 10.2.1 or later\cgalFootnote{\cgalFootnoteCode{https://gcc.gnu.org/}} |
| | Apple `Clang` compiler versions 10.0.1, 12.0.5, and 13.0.0 |
@@ -131,7 +131,7 @@ Overview page. In order to use Eigen in \cgal programs, the
executables should be linked with the CMake imported target
`CGAL::Eigen3_support` provided in `CGAL_Eigen3_support.cmake`.
-The \eigen web site is `http://eigen.tuxfamily.org`.
+The \eigen web site is `https://eigen.tuxfamily.org`.
\subsection thirdpartyOpenGR OpenGR
@@ -213,7 +213,7 @@ the handling of \pdb data.
In \cgal, the \esbtl is used in an example of the \ref PkgSkinSurface3 package.
-It can be downloaded from `http://esbtl.sourceforge.net/`.
+It can be downloaded from `https://esbtl.sourceforge.net/`.
\subsection thirdpartyTBB Intel TBB
@@ -309,7 +309,7 @@ The \glpk web site is `https://www.
In \cgal, \scip provides an optional linear integer program solver in the \ref PkgPolygonalSurfaceReconstruction package.
In order to use \scip in \cgal programs, the executables should be linked with the CMake imported target `CGAL::SCIP_support` provided in `CGAL_SCIP_support.cmake`.
-The \scip web site is `http://scip.zib.de/`.
+The \scip web site is `https://www.scipopt.org/`.
\subsection thirdpartyOSQP OSQP
diff --git a/Documentation/doc/Documentation/main.txt b/Documentation/doc/Documentation/main.txt
index 085a2ad83b6..2026356b76c 100644
--- a/Documentation/doc/Documentation/main.txt
+++ b/Documentation/doc/Documentation/main.txt
@@ -35,7 +35,7 @@ Head over to \ref general_intro to learn how to obtain, install, and use \cgal.
\cgal is distributed under a dual-license scheme. \cgal can be used
together with Open Source software free of charge. Using \cgal in
other contexts can be done by obtaining a commercial license from
-[GeometryFactory](http://www.geometryfactory.com). For more details
+[GeometryFactory](https://www.geometryfactory.com). For more details
see the \ref license "License" page.
-$generatedby
+$generatedby $doxygenversion
diff --git a/Documentation/doc/resources/1.8.13/header.html b/Documentation/doc/resources/1.8.13/header.html
index 8c8b86f5b9d..aaa5e95ea30 100644
--- a/Documentation/doc/resources/1.8.13/header.html
+++ b/Documentation/doc/resources/1.8.13/header.html
@@ -1,6 +1,6 @@
-
+
diff --git a/Documentation/doc/resources/1.8.13/header_package.html b/Documentation/doc/resources/1.8.13/header_package.html
index 544fd3ced7f..9e6fe125d50 100644
--- a/Documentation/doc/resources/1.8.13/header_package.html
+++ b/Documentation/doc/resources/1.8.13/header_package.html
@@ -1,6 +1,6 @@
-
+
diff --git a/Documentation/doc/resources/1.8.14/BaseDoxyfile.in b/Documentation/doc/resources/1.8.14/BaseDoxyfile.in
index 44a6b9f72b3..1a59e5d2d97 100644
--- a/Documentation/doc/resources/1.8.14/BaseDoxyfile.in
+++ b/Documentation/doc/resources/1.8.14/BaseDoxyfile.in
@@ -1,7 +1,7 @@
# Doxyfile 1.8.14
# This file describes the settings to be used by the documentation system
-# doxygen (www.doxygen.org) for a project.
+# doxygen (https://www.doxygen.nl/) for a project.
#
# All text after a double hash (##) is considered a comment and is placed in
# front of the TAG it is preceding.
@@ -404,7 +404,7 @@ EXTENSION_MAPPING = txt=C++
# If the MARKDOWN_SUPPORT tag is enabled then doxygen pre-processes all comments
# according to the Markdown format, which allows for more readable
-# documentation. See http://daringfireball.net/projects/markdown/ for details.
+# documentation. See https://daringfireball.net/projects/markdown/ for details.
# The output of markdown processing is further processed by doxygen, so you can
# mix doxygen, HTML, and XML commands with Markdown formatting. Disable only in
# case of backward compatibilities issues.
@@ -1333,7 +1333,7 @@ HTML_INDEX_NUM_ENTRIES = 100
# If the GENERATE_DOCSET tag is set to YES, additional index files will be
# generated that can be used as input for Apple's Xcode 3 integrated development
-# environment (see: https://developer.apple.com/tools/xcode/), introduced with
+# environment (see: https://developer.apple.com/xcode/), introduced with
# OSX 10.5 (Leopard). To create a documentation set, doxygen will generate a
# Makefile in the HTML output directory. Running make will produce the docset in
# that directory and running make install will install the docset in
@@ -1601,7 +1601,7 @@ USE_MATHJAX = YES
# When MathJax is enabled you can set the default output format to be used for
# the MathJax output. See the MathJax site (see:
-# http://docs.mathjax.org/en/latest/output.html) for more details.
+# https://docs.mathjax.org/en/latest/output/index.html) for more details.
# Possible values are: HTML-CSS (which is slower, but has the best
# compatibility), NativeMML (i.e. MathML) and SVG.
# The default value is: HTML-CSS.
@@ -1632,7 +1632,7 @@ MATHJAX_EXTENSIONS = TeX/AMSmath \
# The MATHJAX_CODEFILE tag can be used to specify a file with javascript pieces
# of code that will be used on startup of the MathJax code. See the MathJax site
-# (see: http://docs.mathjax.org/en/latest/output.html) for more details. For an
+# (see: https://docs.mathjax.org/en/latest/output/index.html) for more details. For an
# example see the documentation.
# This tag requires that the tag USE_MATHJAX is set to YES.
@@ -2062,7 +2062,7 @@ DOCBOOK_PROGRAMLISTING = NO
#---------------------------------------------------------------------------
# If the GENERATE_AUTOGEN_DEF tag is set to YES, doxygen will generate an
-# AutoGen Definitions (see http://autogen.sourceforge.net/) file that captures
+# AutoGen Definitions (see https://autogen.sourceforge.net/) file that captures
# the structure of the code including all documentation. Note that this feature
# is still experimental and incomplete at the moment.
# The default value is: NO.
@@ -2266,7 +2266,7 @@ HIDE_UNDOC_RELATIONS = YES
# If you set the HAVE_DOT tag to YES then doxygen will assume the dot tool is
# available from the path. This tool is part of Graphviz (see:
-# http://www.graphviz.org/), a graph visualization toolkit from AT&T and Lucent
+# https://www.graphviz.org/), a graph visualization toolkit from AT&T and Lucent
# Bell Labs. The other options in this section have no effect if this option is
# set to NO
# The default value is: NO.
@@ -2421,7 +2421,7 @@ DIRECTORY_GRAPH = NO
# The DOT_IMAGE_FORMAT tag can be used to set the image format of the images
# generated by dot. For an explanation of the image formats see the section
# output formats in the documentation of the dot tool (Graphviz (see:
-# http://www.graphviz.org/)).
+# https://www.graphviz.org/)).
# Note: If you choose svg you need to set HTML_FILE_EXTENSION to xhtml in order
# to make the SVG files visible in IE 9+ (other browsers do not have this
# requirement).
diff --git a/Documentation/doc/resources/1.8.14/footer.html b/Documentation/doc/resources/1.8.14/footer.html
index a1ef3c24ea8..379470c59e2 100644
--- a/Documentation/doc/resources/1.8.14/footer.html
+++ b/Documentation/doc/resources/1.8.14/footer.html
@@ -8,14 +8,14 @@ move the footer to the bottom of the page. -->
-$generatedby
+$generatedby $doxygenversion
diff --git a/Documentation/doc/resources/1.8.14/header.html b/Documentation/doc/resources/1.8.14/header.html
index 8c8b86f5b9d..aaa5e95ea30 100644
--- a/Documentation/doc/resources/1.8.14/header.html
+++ b/Documentation/doc/resources/1.8.14/header.html
@@ -1,6 +1,6 @@
-
+
diff --git a/Documentation/doc/resources/1.8.14/header_package.html b/Documentation/doc/resources/1.8.14/header_package.html
index 89f76a8a441..f429c63135d 100644
--- a/Documentation/doc/resources/1.8.14/header_package.html
+++ b/Documentation/doc/resources/1.8.14/header_package.html
@@ -1,6 +1,6 @@
-
+
diff --git a/Documentation/doc/resources/1.8.20/BaseDoxyfile.in b/Documentation/doc/resources/1.8.20/BaseDoxyfile.in
index 7f258d33a4b..f950a6836db 100644
--- a/Documentation/doc/resources/1.8.20/BaseDoxyfile.in
+++ b/Documentation/doc/resources/1.8.20/BaseDoxyfile.in
@@ -1,7 +1,7 @@
# Doxyfile 1.8.20
# This file describes the settings to be used by the documentation system
-# doxygen (www.doxygen.org) for a project.
+# doxygen (https://www.doxygen.nl/) for a project.
#
# All text after a double hash (##) is considered a comment and is placed in
# front of the TAG it is preceding.
@@ -1683,7 +1683,7 @@ USE_MATHJAX = YES
# When MathJax is enabled you can set the default output format to be used for
# the MathJax output. See the MathJax site (see:
-# http://docs.mathjax.org/en/latest/output.html) for more details.
+# https://docs.mathjax.org/en/latest/output/index.html) for more details.
# Possible values are: HTML-CSS (which is slower, but has the best
# compatibility), NativeMML (i.e. MathML) and SVG.
# The default value is: HTML-CSS.
@@ -1714,7 +1714,7 @@ MATHJAX_EXTENSIONS = TeX/AMSmath \
# The MATHJAX_CODEFILE tag can be used to specify a file with javascript pieces
# of code that will be used on startup of the MathJax code. See the MathJax site
-# (see: http://docs.mathjax.org/en/latest/output.html) for more details. For an
+# (see: https://docs.mathjax.org/en/latest/output/index.html) for more details. For an
# example see the documentation.
# This tag requires that the tag USE_MATHJAX is set to YES.
@@ -2146,7 +2146,7 @@ DOCBOOK_OUTPUT = docbook
#---------------------------------------------------------------------------
# If the GENERATE_AUTOGEN_DEF tag is set to YES, doxygen will generate an
-# AutoGen Definitions (see http://autogen.sourceforge.net/) file that captures
+# AutoGen Definitions (see https://autogen.sourceforge.net/) file that captures
# the structure of the code including all documentation. Note that this feature
# is still experimental and incomplete at the moment.
# The default value is: NO.
@@ -2350,7 +2350,7 @@ HIDE_UNDOC_RELATIONS = YES
# If you set the HAVE_DOT tag to YES then doxygen will assume the dot tool is
# available from the path. This tool is part of Graphviz (see:
-# http://www.graphviz.org/), a graph visualization toolkit from AT&T and Lucent
+# https://www.graphviz.org/), a graph visualization toolkit from AT&T and Lucent
# Bell Labs. The other options in this section have no effect if this option is
# set to NO
# The default value is: NO.
@@ -2505,7 +2505,7 @@ DIRECTORY_GRAPH = NO
# The DOT_IMAGE_FORMAT tag can be used to set the image format of the images
# generated by dot. For an explanation of the image formats see the section
# output formats in the documentation of the dot tool (Graphviz (see:
-# http://www.graphviz.org/)).
+# https://www.graphviz.org/)).
# Note: If you choose svg you need to set HTML_FILE_EXTENSION to xhtml in order
# to make the SVG files visible in IE 9+ (other browsers do not have this
# requirement).
diff --git a/Documentation/doc/resources/1.8.20/footer.html b/Documentation/doc/resources/1.8.20/footer.html
index cd9ad4553bc..28e5afe0f39 100644
--- a/Documentation/doc/resources/1.8.20/footer.html
+++ b/Documentation/doc/resources/1.8.20/footer.html
@@ -7,13 +7,13 @@ move the footer to the bottom of the page. -->
$navpath
-
$generatedby $doxygenversion
+
$generatedby $doxygenversion
-$generatedby $doxygenversion
+$generatedby $doxygenversion
diff --git a/Documentation/doc/resources/1.8.20/header.html b/Documentation/doc/resources/1.8.20/header.html
index 50e4e4dcb49..c0530eec8bf 100644
--- a/Documentation/doc/resources/1.8.20/header.html
+++ b/Documentation/doc/resources/1.8.20/header.html
@@ -1,6 +1,6 @@
-
+
diff --git a/Documentation/doc/resources/1.8.20/header_package.html b/Documentation/doc/resources/1.8.20/header_package.html
index 007d84e7b10..d2a1ed6051b 100644
--- a/Documentation/doc/resources/1.8.20/header_package.html
+++ b/Documentation/doc/resources/1.8.20/header_package.html
@@ -1,6 +1,6 @@
-
+
diff --git a/Documentation/doc/resources/1.8.4/BaseDoxyfile.in b/Documentation/doc/resources/1.8.4/BaseDoxyfile.in
index 45d422384df..10f3050a8f3 100644
--- a/Documentation/doc/resources/1.8.4/BaseDoxyfile.in
+++ b/Documentation/doc/resources/1.8.4/BaseDoxyfile.in
@@ -1,7 +1,7 @@
# Doxyfile 1.8.4
# This file describes the settings to be used by the documentation system
-# doxygen (www.doxygen.org) for a project.
+# doxygen (https://www.doxygen.nl/) for a project.
#
# All text after a double hash (##) is considered a comment and is placed
# in front of the TAG it is preceding .
@@ -20,7 +20,7 @@
# that follow. The default is UTF-8 which is also the encoding used for all
# text before the first occurrence of this tag. Doxygen uses libiconv (or the
# iconv built into libc) for the transcoding. See
-# http://www.gnu.org/software/libiconv for the list of possible encodings.
+# https://www.gnu.org/software/libiconv for the list of possible encodings.
DOXYFILE_ENCODING = UTF-8
@@ -409,7 +409,7 @@ EXTENSION_MAPPING =
# If MARKDOWN_SUPPORT is enabled (the default) then doxygen pre-processes all
# comments according to the Markdown format, which allows for more readable
-# documentation. See http://daringfireball.net/projects/markdown/ for details.
+# documentation. See https://daringfireball.net/projects/markdown/ for details.
# The output of markdown processing is further processed by doxygen, so you
# can mix doxygen, HTML, and XML commands with Markdown formatting.
# Disable only in case of backward compatibilities issues.
@@ -754,7 +754,7 @@ LAYOUT_FILE = ${CGAL_DOC_RESOURCE_DIR}/DoxygenLayoutPackage.xml
# containing the references data. This must be a list of .bib files. The
# .bib extension is automatically appended if omitted. Using this command
# requires the bibtex tool to be installed. See also
-# http://en.wikipedia.org/wiki/BibTeX for more info. For LaTeX the style
+# https://en.wikipedia.org/wiki/BibTeX for more info. For LaTeX the style
# of the bibliography can be controlled using LATEX_BIB_STYLE. To use this
# feature you need bibtex and perl available in the search path. Do not use
# file names with spaces, bibtex cannot handle them.
@@ -827,7 +827,7 @@ INPUT =
# This tag can be used to specify the character encoding of the source files
# that doxygen parses. Internally doxygen uses the UTF-8 encoding, which is
# also the default input encoding. Doxygen uses libiconv (or the iconv built
-# into libc) for the transcoding. See http://www.gnu.org/software/libiconv for
+# into libc) for the transcoding. See https://www.gnu.org/software/libiconv for
# the list of possible encodings.
INPUT_ENCODING = UTF-8
@@ -1005,7 +1005,7 @@ REFERENCES_LINK_SOURCE = YES
# If the USE_HTAGS tag is set to YES then the references to source code
# will point to the HTML generated by the htags(1) tool instead of doxygen
# built-in source browser. The htags tool is part of GNU's global source
-# tagging system (see http://www.gnu.org/software/global/global.html). You
+# tagging system (see https://www.gnu.org/software/global/global.html). You
# will need version 4.8.6 or higher.
USE_HTAGS = NO
@@ -1110,7 +1110,7 @@ HTML_EXTRA_FILES =
# The HTML_COLORSTYLE_HUE tag controls the color of the HTML output.
# Doxygen will adjust the colors in the style sheet and background images
# according to this color. Hue is specified as an angle on a colorwheel,
-# see http://en.wikipedia.org/wiki/Hue for more information.
+# see https://en.wikipedia.org/wiki/Hue for more information.
# For instance the value 0 represents red, 60 is yellow, 120 is green,
# 180 is cyan, 240 is blue, 300 purple, and 360 is red again.
# The allowed range is 0 to 359.
@@ -1251,25 +1251,25 @@ QCH_FILE =
# The QHP_NAMESPACE tag specifies the namespace to use when generating
# Qt Help Project output. For more information please see
-# http://doc.trolltech.com/qthelpproject.html#namespace
+# https://doc.qt.io/archives/qt-4.8/qthelpproject.html#namespace
QHP_NAMESPACE = org.doxygen.Project
# The QHP_VIRTUAL_FOLDER tag specifies the namespace to use when generating
# Qt Help Project output. For more information please see
-# http://doc.trolltech.com/qthelpproject.html#virtual-folders
+# https://doc.qt.io/archives/qt-4.8/qthelpproject.html#virtual-folders
QHP_VIRTUAL_FOLDER = doc
# If QHP_CUST_FILTER_NAME is set, it specifies the name of a custom filter to
# add. For more information please see
-# http://doc.trolltech.com/qthelpproject.html#custom-filters
+# https//doc.qt.io/archives/qt-4.8/qthelpproject.html#custom-filters
QHP_CUST_FILTER_NAME =
# The QHP_CUST_FILT_ATTRS tag specifies the list of the attributes of the
# custom filter to add. For more information please see
-#
+#
# Qt Help Project / Custom Filters.
QHP_CUST_FILTER_ATTRS =
@@ -1277,7 +1277,7 @@ QHP_CUST_FILTER_ATTRS =
# The QHP_SECT_FILTER_ATTRS tag specifies the list of the attributes this
# project's
# filter section matches.
-#
+#
# Qt Help Project / Filter Attributes.
QHP_SECT_FILTER_ATTRS =
@@ -1361,7 +1361,7 @@ FORMULA_FONTSIZE = 10
FORMULA_TRANSPARENT = YES
# Enable the USE_MATHJAX option to render LaTeX formulas using MathJax
-# (see http://www.mathjax.org) which uses client side Javascript for the
+# (see https://www.mathjax.org) which uses client side Javascript for the
# rendering instead of using prerendered bitmaps. Use this if you do not
# have LaTeX installed or if you want to formulas look prettier in the HTML
# output. When enabled you may also need to install MathJax separately and
@@ -1384,7 +1384,7 @@ MATHJAX_FORMAT = HTML-CSS
# the MathJax Content Delivery Network so you can quickly see the result without
# installing MathJax.
# However, it is strongly recommended to install a local
-# copy of MathJax from http://www.mathjax.org before deployment.
+# copy of MathJax from https://www.mathjax.org before deployment.
MATHJAX_RELPATH = ../../MathJax/
@@ -1560,7 +1560,7 @@ LATEX_SOURCE_CODE = NO
# The LATEX_BIB_STYLE tag can be used to specify the style to use for the
# bibliography, e.g. plainnat, or ieeetr. The default style is "plain". See
-# http://en.wikipedia.org/wiki/BibTeX for more info.
+# https://en.wikipedia.org/wiki/BibTeX for more info.
LATEX_BIB_STYLE = plain
@@ -1850,7 +1850,7 @@ CLASS_DIAGRAMS = NO
# You can define message sequence charts within doxygen comments using the \msc
# command. Doxygen will then run the mscgen tool (see
-# http://www.mcternan.me.uk/mscgen/) to produce the chart and insert it in the
+# https://www.mcternan.me.uk/mscgen/) to produce the chart and insert it in the
# documentation. The MSCGEN_PATH tag allows you to specify the directory where
# the mscgen tool resides. If left empty the tool is assumed to be found in the
# default search path.
diff --git a/Documentation/doc/resources/1.8.4/footer.html b/Documentation/doc/resources/1.8.4/footer.html
index 8b23c63651f..5c8bc85e026 100644
--- a/Documentation/doc/resources/1.8.4/footer.html
+++ b/Documentation/doc/resources/1.8.4/footer.html
@@ -5,14 +5,14 @@
diff --git a/Documentation/doc/resources/1.9.3/BaseDoxyfile.in b/Documentation/doc/resources/1.9.3/BaseDoxyfile.in
index d95cfc9dd5a..775ba2ce757 100644
--- a/Documentation/doc/resources/1.9.3/BaseDoxyfile.in
+++ b/Documentation/doc/resources/1.9.3/BaseDoxyfile.in
@@ -1,7 +1,7 @@
# Doxyfile 1.9.3
# This file describes the settings to be used by the documentation system
-# doxygen (www.doxygen.org) for a project.
+# doxygen (https://www.doxygen.nl/) for a project.
#
# All text after a double hash (##) is considered a comment and is placed in
# front of the TAG it is preceding.
@@ -1688,7 +1688,7 @@ USE_MATHJAX = YES
# When MathJax is enabled you can set the default output format to be used for
# the MathJax output. See the MathJax site (see:
-# http://docs.mathjax.org/en/latest/output.html) for more details.
+# https://docs.mathjax.org/en/latest/output/index.html) for more details.
# Possible values are: HTML-CSS (which is slower, but has the best
# compatibility), NativeMML (i.e. MathML) and SVG.
# The default value is: HTML-CSS.
@@ -1719,7 +1719,7 @@ MATHJAX_EXTENSIONS = TeX/AMSmath \
# The MATHJAX_CODEFILE tag can be used to specify a file with javascript pieces
# of code that will be used on startup of the MathJax code. See the MathJax site
-# (see: http://docs.mathjax.org/en/latest/output.html) for more details. For an
+# (see: https://docs.mathjax.org/en/latest/output/index.html) for more details. For an
# example see the documentation.
# This tag requires that the tag USE_MATHJAX is set to YES.
@@ -2151,7 +2151,7 @@ DOCBOOK_OUTPUT = docbook
#---------------------------------------------------------------------------
# If the GENERATE_AUTOGEN_DEF tag is set to YES, doxygen will generate an
-# AutoGen Definitions (see http://autogen.sourceforge.net/) file that captures
+# AutoGen Definitions (see https://autogen.sourceforge.net/) file that captures
# the structure of the code including all documentation. Note that this feature
# is still experimental and incomplete at the moment.
# The default value is: NO.
@@ -2261,7 +2261,7 @@ PREDEFINED = DOXYGEN_RUNNING \
"CGAL_NP_TEMPLATE_PARAMETERS_2=NamedParameters2 = CGAL::parameters::Default_named_parameter" \
"CGAL_NP_CLASS_2=NamedParameters2" \
CGAL_DEPRECATED
-
+
# If the MACRO_EXPANSION and EXPAND_ONLY_PREDEF tags are set to YES then this
# tag can be used to specify a list of macro names that should be expanded. The
@@ -2347,7 +2347,7 @@ HIDE_UNDOC_RELATIONS = YES
# If you set the HAVE_DOT tag to YES then doxygen will assume the dot tool is
# available from the path. This tool is part of Graphviz (see:
-# http://www.graphviz.org/), a graph visualization toolkit from AT&T and Lucent
+# https://www.graphviz.org/), a graph visualization toolkit from AT&T and Lucent
# Bell Labs. The other options in this section have no effect if this option is
# set to NO
# The default value is: NO.
@@ -2507,7 +2507,7 @@ DIRECTORY_GRAPH = NO
# The DOT_IMAGE_FORMAT tag can be used to set the image format of the images
# generated by dot. For an explanation of the image formats see the section
# output formats in the documentation of the dot tool (Graphviz (see:
-# http://www.graphviz.org/)).
+# https://www.graphviz.org/)).
# Note: If you choose svg you need to set HTML_FILE_EXTENSION to xhtml in order
# to make the SVG files visible in IE 9+ (other browsers do not have this
# requirement).
diff --git a/Documentation/doc/resources/1.9.3/footer.html b/Documentation/doc/resources/1.9.3/footer.html
index cd9ad4553bc..28e5afe0f39 100644
--- a/Documentation/doc/resources/1.9.3/footer.html
+++ b/Documentation/doc/resources/1.9.3/footer.html
@@ -7,13 +7,13 @@ move the footer to the bottom of the page. -->
$navpath
-
$generatedby $doxygenversion
+
$generatedby $doxygenversion
-$generatedby $doxygenversion
+$generatedby $doxygenversion
diff --git a/Documentation/doc/resources/1.9.3/header.html b/Documentation/doc/resources/1.9.3/header.html
index 50e4e4dcb49..c0530eec8bf 100644
--- a/Documentation/doc/resources/1.9.3/header.html
+++ b/Documentation/doc/resources/1.9.3/header.html
@@ -1,6 +1,6 @@
-
+
diff --git a/Documentation/doc/resources/1.9.3/header_package.html b/Documentation/doc/resources/1.9.3/header_package.html
index 007d84e7b10..d2a1ed6051b 100644
--- a/Documentation/doc/resources/1.9.3/header_package.html
+++ b/Documentation/doc/resources/1.9.3/header_package.html
@@ -1,6 +1,6 @@
-
+
diff --git a/Documentation/doc/scripts/generate_how_to_cite.py b/Documentation/doc/scripts/generate_how_to_cite.py
index e1108d6a51f..470c71d4e45 100644
--- a/Documentation/doc/scripts/generate_how_to_cite.py
+++ b/Documentation/doc/scripts/generate_how_to_cite.py
@@ -46,7 +46,7 @@ software.
If you want to cite the \cgal Library or project as a whole, please
-- cite: \cgal, Computational Geometry Algorithms Library, https://www.cgal.org
+- cite: \cgal, Computational Geometry Algorithms Library, https://www.cgal.org
- use the first bibtex entry from the file how_to_cite_cgal.bib.
## Citing the User and Reference Manual ##
@@ -65,7 +65,7 @@ If you want to refer to \cgal manual, please cite the appropriate
The \cgal Project.
\cgal User and Reference Manual.
\cgal Editorial Board, ${CGAL_CREATED_VERSION_NUM} edition, ${CGAL_BUILD_YEAR4}.
-[ bib |
+[ bib |
http ]
@@ -80,7 +80,7 @@ result_txt_footer=r"""
"""
pre_html=r"""
-
+
diff --git a/Documentation/doc/scripts/html_output_post_processing.py b/Documentation/doc/scripts/html_output_post_processing.py
index 44d15aa6d70..5402d7bc50f 100755
--- a/Documentation/doc/scripts/html_output_post_processing.py
+++ b/Documentation/doc/scripts/html_output_post_processing.py
@@ -55,7 +55,7 @@ def write_out_html(d, fn):
f = codecs.open(fn, 'w', encoding='utf-8')
# this is the normal doxygen doctype, which is thrown away by pyquery
f.write('\n')
- f.write('')
+ f.write('')
if d.html() is not None:
f.write(d.html())
f.write('\n')
@@ -85,7 +85,7 @@ def clean_doc():
for fn in duplicate_files:
os.remove(fn)
-# from http://stackoverflow.com/a/1597755/105672
+# from https://stackoverflow.com/a/1597755/105672
def re_replace_in_file(pat, s_after, fname):
# first, see if the pattern is even in the file.
with codecs.open(fname, encoding='utf-8') as f:
diff --git a/Filtered_kernel/TODO b/Filtered_kernel/TODO
index 477746d7bce..7e1b5441ad9 100644
--- a/Filtered_kernel/TODO
+++ b/Filtered_kernel/TODO
@@ -140,7 +140,7 @@ except we could merge stuff with Olivier's Fixed !
So the good choice seems to be to have data stored in each predicate object,
and having the kernel store a predicate object for each predicate.
Then the orientation_2_object() simply returns a reference to it.
-
+
Then it means algorithms should use one "global" object per predicate (e.g.
one orientation object for a whole Triangulation). Except for cases where
they actually want different contexts.
diff --git a/Filtered_kernel/include/CGAL/Filtered_kernel.h b/Filtered_kernel/include/CGAL/Filtered_kernel.h
index 7e7c21ef79f..182ba3c4d99 100644
--- a/Filtered_kernel/include/CGAL/Filtered_kernel.h
+++ b/Filtered_kernel/include/CGAL/Filtered_kernel.h
@@ -81,13 +81,16 @@ struct Filtered_kernel_base
Approximate_kernel approximate_kernel() const { return {}; }
// We change the predicates.
-#define CGAL_Kernel_pred(P, Pf) \
- typedef Filtered_predicate P; \
+#define CGAL_Kernel_pred_RT_or_FT(P, Pf) \
+ typedef Filtered_predicate_RT_FT P; \
P Pf() const { return P(); }
-#define CGAL_Kernel_pred_RT(P, Pf) \
- typedef Filtered_predicate P; \
- P Pf() const { return P(); }
+#define CGAL_Kernel_pred(P, Pf) CGAL_Kernel_pred_RT_or_FT(P, Pf)
// We don't touch the constructions.
#define CGAL_Kernel_cons(Y,Z)
diff --git a/Filtered_kernel/include/CGAL/Filtered_kernel/internal/Static_filters/Angle_3.h b/Filtered_kernel/include/CGAL/Filtered_kernel/internal/Static_filters/Angle_3.h
index ac57decb63e..e9428fd2917 100644
--- a/Filtered_kernel/include/CGAL/Filtered_kernel/internal/Static_filters/Angle_3.h
+++ b/Filtered_kernel/include/CGAL/Filtered_kernel/internal/Static_filters/Angle_3.h
@@ -21,7 +21,7 @@
#include
#include
-// inspired from http://cag.csail.mit.edu/~amy/papers/box-jgt.pdf
+// inspired from https://people.csail.mit.edu/amy/papers/box-jgt.pdf
namespace CGAL {
diff --git a/Filtered_kernel/include/CGAL/Filtered_kernel/internal/Static_filters/Do_intersect_3.h b/Filtered_kernel/include/CGAL/Filtered_kernel/internal/Static_filters/Do_intersect_3.h
index 3b94f56663c..2b0ef97d7fc 100644
--- a/Filtered_kernel/include/CGAL/Filtered_kernel/internal/Static_filters/Do_intersect_3.h
+++ b/Filtered_kernel/include/CGAL/Filtered_kernel/internal/Static_filters/Do_intersect_3.h
@@ -26,7 +26,7 @@
#include
-// inspired from http://cag.csail.mit.edu/~amy/papers/box-jgt.pdf
+// inspired from https://people.csail.mit.edu/amy/papers/box-jgt.pdf
namespace CGAL {
diff --git a/Filtered_kernel/include/CGAL/Filtered_predicate.h b/Filtered_kernel/include/CGAL/Filtered_predicate.h
index 2adad47f329..8cbcaa2835a 100644
--- a/Filtered_kernel/include/CGAL/Filtered_predicate.h
+++ b/Filtered_kernel/include/CGAL/Filtered_predicate.h
@@ -19,6 +19,8 @@
#include
#include
+#include
+
namespace CGAL {
// This template class is a wrapper that implements the filtering for any
@@ -84,15 +86,8 @@ public:
template
result_type
- operator()(const Args&... args) const;
-};
-
-template
- template
-typename Filtered_predicate::result_type
-Filtered_predicate::
operator()(const Args&... args) const
-{
+ {
CGAL_BRANCH_PROFILER(std::string(" failures/calls to : ") + std::string(CGAL_PRETTY_FUNCTION), tmp);
// Protection is outside the try block as VC8 has the CGAL_CFG_FPU_ROUNDING_MODE_UNWINDING_VC_BUG
{
@@ -109,8 +104,76 @@ Filtered_predicate::
Protect_FPU_rounding p(CGAL_FE_TONEAREST);
CGAL_expensive_assertion(FPU_get_cw() == CGAL_FE_TONEAREST);
return ep(c2e(args)...);
-}
+ }
+};
-} //namespace CGAL
+template
+class Filtered_predicate_RT_FT
+{
+ C2E_RT c2e_rt;
+ C2E_FT c2e_ft;
+ C2A c2a;
+ EP_RT ep_rt;
+ EP_FT ep_ft;
+ AP ap;
+
+ using Ares = typename Remove_needs_FT::Type;
+
+public:
+ using result_type = typename Remove_needs_FT::Type;
+
+private:
+ template
+ struct Call_operator_needs_FT
+ {
+ using Actual_approx_res = decltype(ap(c2a(std::declval())...));
+ using Approx_res = std::remove_cv_t >;
+ enum { value = std::is_same >::value };
+ };
+
+ template ::value>* = nullptr>
+ result_type call(const Args&... args) const { return ep_ft(c2e_ft(args)...); }
+
+ template ::value>* = nullptr>
+ result_type call(const Args&... args) const { return ep_rt(c2e_rt(args)...); }
+
+public:
+ // ## Important note
+ //
+ // If you want to remove of rename that member function template `needs_FT`,
+ // please also change the lines with
+ // `CGAL_GENERATE_MEMBER_DETECTOR(needs_FT);`
+ // or `has_needs_FT` in
+ // the file `Kernel_23/test/Kernel_23/include/CGAL/_test_new_3.h`.
+ template
+ bool needs_FT(const Args&...) const { return Call_operator_needs_FT::value; }
+
+ template
+ result_type
+ operator()(const Args&... args) const
+ {
+ CGAL_BRANCH_PROFILER(std::string(" failures/calls to : ") + std::string(CGAL_PRETTY_FUNCTION), tmp);
+ // Protection is outside the try block as VC8 has the CGAL_CFG_FPU_ROUNDING_MODE_UNWINDING_VC_BUG
+ {
+ Protect_FPU_rounding p;
+ try
+ {
+ Ares res = ap(c2a(args)...);
+ if (is_certain(res))
+ return get_certain(res);
+ }
+ catch (Uncertain_conversion_exception&) {}
+ }
+ CGAL_BRANCH_PROFILER_BRANCH(tmp);
+ Protect_FPU_rounding p(CGAL_FE_TONEAREST);
+ CGAL_expensive_assertion(FPU_get_cw() == CGAL_FE_TONEAREST);
+
+ return call(args...);
+ }
+};
+
+} // namespace CGAL
#endif // CGAL_FILTERED_PREDICATE_H
diff --git a/Filtered_kernel/include/CGAL/Lazy_kernel.h b/Filtered_kernel/include/CGAL/Lazy_kernel.h
index c88f93e3acf..08a6ebb41a0 100644
--- a/Filtered_kernel/include/CGAL/Lazy_kernel.h
+++ b/Filtered_kernel/include/CGAL/Lazy_kernel.h
@@ -89,7 +89,7 @@ protected:
// Exact_kernel = exact kernel that will be made lazy
// Kernel = lazy kernel
-// the Generic base simplies applies the generic magic functor stupidly.
+// the Generic base simply applies the generic magic functor stupidly.
// then the real base fixes up a few special cases.
template < typename EK_, typename AK_, typename E2A_, typename Kernel_ >
class Lazy_kernel_generic_base : protected internal::Enum_holder
diff --git a/Generalized_map/doc/Generalized_map/Generalized_map.txt b/Generalized_map/doc/Generalized_map/Generalized_map.txt
index 09ad37a4946..0b08884f40a 100644
--- a/Generalized_map/doc/Generalized_map/Generalized_map.txt
+++ b/Generalized_map/doc/Generalized_map/Generalized_map.txt
@@ -551,7 +551,7 @@ Let d0 \f$ \in \f$ D be a dart. Given i, 0 \f$ \leq \f$
\section Generalized_mapDesign Design and Implementation History
-The code of this package followed the code of Combinatorial maps and was inspired by Moka, a 3D topological modeler that uses 3D generalized maps (http://moka-modeller.sourceforge.net/).
+The code of this package followed the code of Combinatorial maps and was inspired by Moka, a 3D topological modeler that uses 3D generalized maps (https://moka-modeller.sourceforge.net/).
*/
} /* namespace CGAL */
diff --git a/GraphicsView/doc/GraphicsView/fig_src/uml-design.graphml b/GraphicsView/doc/GraphicsView/fig_src/uml-design.graphml
index b4d866c7279..39d1878397c 100644
--- a/GraphicsView/doc/GraphicsView/fig_src/uml-design.graphml
+++ b/GraphicsView/doc/GraphicsView/fig_src/uml-design.graphml
@@ -1,5 +1,5 @@
-
+
diff --git a/Heat_method_3/include/CGAL/Heat_method_3/Surface_mesh_geodesic_distances_3.h b/Heat_method_3/include/CGAL/Heat_method_3/Surface_mesh_geodesic_distances_3.h
index b257c53843d..0dead11c3ca 100644
--- a/Heat_method_3/include/CGAL/Heat_method_3/Surface_mesh_geodesic_distances_3.h
+++ b/Heat_method_3/include/CGAL/Heat_method_3/Surface_mesh_geodesic_distances_3.h
@@ -529,22 +529,19 @@ private:
pj = p_j;
pk = p_k;
- const double cotan_i = CGAL::to_double(
- CGAL::Weights::cotangent(pk, pi, pj, traits));
+ const double cotan_i = CGAL::to_double(CGAL::Weights::cotangent(pk, pi, pj, traits));
m_cotan_matrix.add_coef(j, k, -(1./2) * cotan_i);
m_cotan_matrix.add_coef(k, j, -(1./2) * cotan_i);
m_cotan_matrix.add_coef(j, j, (1./2) * cotan_i);
m_cotan_matrix.add_coef(k, k, (1./2) * cotan_i);
- const double cotan_j = CGAL::to_double(
- CGAL::Weights::cotangent(pk, pj, pi, traits));
+ const double cotan_j = CGAL::to_double(CGAL::Weights::cotangent(pk, pj, pi, traits));
m_cotan_matrix.add_coef(i, k, -(1./2) * cotan_j);
m_cotan_matrix.add_coef(k, i, -(1./2) * cotan_j);
m_cotan_matrix.add_coef(i, i, (1./2) * cotan_j);
m_cotan_matrix.add_coef(k, k, (1./2) * cotan_j);
- const double cotan_k = CGAL::to_double(
- CGAL::Weights::cotangent(pj, pk, pi, traits));
+ const double cotan_k = CGAL::to_double(CGAL::Weights::cotangent(pj, pk, pi, traits));
m_cotan_matrix.add_coef(i, j, -(1./2) * cotan_k);
m_cotan_matrix.add_coef(j, i, -(1./2) * cotan_k);
m_cotan_matrix.add_coef(i, i, (1./2) * cotan_k);
@@ -553,8 +550,7 @@ private:
const Vector_3 v_ij = construct_vector(p_i, p_j);
const Vector_3 v_ik = construct_vector(p_i, p_k);
const Vector_3 cross = cross_product(v_ij, v_ik);
- const double norm_cross = CGAL::sqrt(
- CGAL::to_double(scalar_product(cross, cross)));
+ const double norm_cross = CGAL::sqrt(CGAL::to_double(scalar_product(cross, cross)));
//double area_face = CGAL::Polygon_mesh_processing::face_area(f,tm);
//cross is 2*area
diff --git a/Hyperbolic_triangulation_2/demo/Hyperbolic_triangulation_2/resources/about_CGAL.html b/Hyperbolic_triangulation_2/demo/Hyperbolic_triangulation_2/resources/about_CGAL.html
index 6b2b2a5d943..f2f0fb9318b 100644
--- a/Hyperbolic_triangulation_2/demo/Hyperbolic_triangulation_2/resources/about_CGAL.html
+++ b/Hyperbolic_triangulation_2/demo/Hyperbolic_triangulation_2/resources/about_CGAL.html
@@ -3,6 +3,6 @@
Computational Geometry Algorithms Library
CGAL provides efficient and reliable geometric algorithms in the form of a C++ library.
diff --git a/Installation/CHANGES.md b/Installation/CHANGES.md
index 6f0523005e2..30e31329e62 100644
--- a/Installation/CHANGES.md
+++ b/Installation/CHANGES.md
@@ -59,6 +59,10 @@ CGAL tetrahedral Delaunay refinement algorithm.
described by the concept `TriangulationDataStructure_2::Face`. The model `CGAL::Hyperbolic_triangulation_face_base_2`
has been adapted correspondingly.
+### [Surface Mesh Simplification](https://doc.cgal.org/5.6/Manual/packages.html#PkgSurfaceMeshSimplification)
+- The stop predicates `Count_stop_predicate` and `Count_ratio_stop_predicate` are renamed to `Edge_count_stop_predicate` and `Edge_count_ratio_stop_predicate`. Older versions have been deprecated.
+- Introduce `Face_count_stop_predicate` and `Face_count_ratio_stop_predicate` that can be used to stop the simplification algorithm based on a desired number of faces in the output, or a ratio between input and output face numbers.
+
[Release 5.5](https://github.com/CGAL/cgal/releases/tag/v5.5)
-----------
@@ -3187,7 +3191,7 @@ Release date: October 2012
- Added more general script to create CMakeLists.txt files:
`cgal_create_CMakeLists`
- Availability tests for C++11 features are now performed with the
- help of [Boost.Config](http://www.boost.org/libs/config). A Boost
+ help of [Boost.Config](https://www.boost.org/libs/config). A Boost
version of 1.40.0 or higher is needed to use C++11 features.
### 2D Arrangement
@@ -3679,7 +3683,7 @@ CGAL 3.7 offers the following improvements and new functionality :
- Some demos now require a version of Qt4 >= 4.3.
- CGAL\_PDB is no longer provided with CGAL. An alternative solution
for people interested in reading PDB files is to use ESBTL
- (http://esbtl.sourceforge.net/).
+ (https://esbtl.sourceforge.net/).
- Fix issues of the CGAL wrappers around the CORE library, on 64 bits
platforms.
diff --git a/Installation/CMakeLists.txt b/Installation/CMakeLists.txt
index 5f506634ba8..8d48e93b39f 100644
--- a/Installation/CMakeLists.txt
+++ b/Installation/CMakeLists.txt
@@ -354,7 +354,7 @@ include(${CGAL_MODULES_DIR}/CGAL_Macros.cmake)
include(${CGAL_MODULES_DIR}/CGAL_enable_end_of_configuration_hook.cmake)
cgal_setup_module_path()
-if(RUNNING_CGAL_AUTO_TEST)
+if(RUNNING_CGAL_AUTO_TEST OR CGAL_TEST_SUITE)
message(STATUS "Operating system:")
execute_process(
COMMAND uname -a
@@ -392,7 +392,7 @@ if(MSVC)
uniquely_add_flags(CGAL_CXX_FLAGS "/fp:except-")
uniquely_add_flags(CGAL_CXX_FLAGS "/bigobj") # Use /bigobj by default
- if(RUNNING_CGAL_AUTO_TEST)
+ if(RUNNING_CGAL_AUTO_TEST OR CGAL_TEST_SUITE)
set(CMAKE_CXX_WARNING_LEVEL
2
CACHE STRING "MSVC C++ compiler warning level" FORCE)
@@ -445,7 +445,7 @@ if(CMAKE_COMPILER_IS_GNUCXX)
if(GCC_FOUND)
- if(RUNNING_CGAL_AUTO_TEST)
+ if(RUNNING_CGAL_AUTO_TEST OR CGAL_TEST_SUITE)
uniquely_add_flags(CGAL_CXX_FLAGS "-Wall")
# Remove -g from the relevant CMAKE_CXX_FLAGS. This will also
# propagate to the rest of the tests, since we overwrite those
@@ -482,7 +482,7 @@ message("== Generate version files (DONE) ==\n")
#
#--------------------------------------------------------------------------------------------------
-if(CGAL_DEV_MODE OR RUNNING_CGAL_AUTO_TEST)
+if(CGAL_DEV_MODE OR RUNNING_CGAL_AUTO_TEST OR CGAL_TEST_SUITE)
message("== Set up flags ==")
# Ugly hack to be compatible with current CGAL testsuite process (as of
@@ -1254,4 +1254,4 @@ if(RUNNING_CGAL_AUTO_TEST OR CGAL_TEST_SUITE)
if(Qt5_FOUND)
message(STATUS "USING Qt5_VERSION = '${Qt5Core_VERSION_STRING}'")
endif()#Qt5_FOUND
-endif()#RUNNING_CGAL_AUTO_TEST
+endif()#RUNNING_CGAL_AUTO_TEST OR CGAL_TEST_SUITE
diff --git a/Installation/LICENSE.GPL b/Installation/LICENSE.GPL
index 94a9ed024d3..ae0725d8014 100644
--- a/Installation/LICENSE.GPL
+++ b/Installation/LICENSE.GPL
@@ -1,7 +1,7 @@
GNU GENERAL PUBLIC LICENSE
Version 3, 29 June 2007
- Copyright (C) 2007 Free Software Foundation, Inc.
+ Copyright (C) 2007 Free Software Foundation, Inc.
Everyone is permitted to copy and distribute verbatim copies
of this license document, but changing it is not allowed.
@@ -645,7 +645,7 @@ the "copyright" line and a pointer to where the full notice is found.
GNU General Public License for more details.
You should have received a copy of the GNU General Public License
- along with this program. If not, see .
+ along with this program. If not, see .
Also add information on how to contact you by electronic and paper mail.
@@ -664,11 +664,11 @@ might be different; for a GUI interface, you would use an "about box".
You should also get your employer (if you work as a programmer) or school,
if any, to sign a "copyright disclaimer" for the program, if necessary.
For more information on this, and how to apply and follow the GNU GPL, see
-.
+.
The GNU General Public License does not permit incorporating your program
into proprietary programs. If your program is a subroutine library, you
may consider it more useful to permit linking proprietary applications with
the library. If this is what you want to do, use the GNU Lesser General
Public License instead of this License. But first, please read
-.
+.
diff --git a/Installation/LICENSE.LGPL b/Installation/LICENSE.LGPL
index 65c5ca88a67..1cd6ad68146 100644
--- a/Installation/LICENSE.LGPL
+++ b/Installation/LICENSE.LGPL
@@ -1,7 +1,7 @@
GNU LESSER GENERAL PUBLIC LICENSE
Version 3, 29 June 2007
- Copyright (C) 2007 Free Software Foundation, Inc.
+ Copyright (C) 2007 Free Software Foundation, Inc.
Everyone is permitted to copy and distribute verbatim copies
of this license document, but changing it is not allowed.
diff --git a/Installation/cmake/modules/CGAL_Common.cmake b/Installation/cmake/modules/CGAL_Common.cmake
index 92de4630099..ce99da6489e 100644
--- a/Installation/cmake/modules/CGAL_Common.cmake
+++ b/Installation/cmake/modules/CGAL_Common.cmake
@@ -4,7 +4,7 @@ option(CGAL_DEV_MODE
"Activate the CGAL developers mode. See https://github.com/CGAL/cgal/wiki/CGAL_DEV_MODE"
$ENV{CGAL_DEV_MODE})
-if(RUNNING_CGAL_AUTO_TEST)
+if(RUNNING_CGAL_AUTO_TEST OR CGAL_TEST_SUITE)
# Just to avoid a warning from CMake if that variable is set on the command line...
endif()
diff --git a/Installation/cmake/modules/CGAL_SetupCGALDependencies.cmake b/Installation/cmake/modules/CGAL_SetupCGALDependencies.cmake
index 790b13331b1..08cdc568ab6 100644
--- a/Installation/cmake/modules/CGAL_SetupCGALDependencies.cmake
+++ b/Installation/cmake/modules/CGAL_SetupCGALDependencies.cmake
@@ -97,8 +97,7 @@ function(CGAL_setup_CGAL_dependencies target)
target_compile_definitions(${target} INTERFACE CGAL_TEST_SUITE=1)
endif()
- # CGAL now requires C++14. `decltype(auto)` is used as a marker of
- # C++14.
+ # CGAL now requires C++14. `decltype(auto)` is used as a marker of C++14.
target_compile_features(${target} INTERFACE cxx_decltype_auto)
use_CGAL_Boost_support(${target} INTERFACE)
@@ -152,7 +151,7 @@ function(CGAL_setup_CGAL_dependencies target)
"-features=extensions;-library=stlport4;-D_GNU_SOURCE")
target_link_libraries(${target} INTERFACE "-library=stlport4")
elseif(CMAKE_CXX_COMPILER_ID MATCHES "GNU")
- if ( RUNNING_CGAL_AUTO_TEST )
+ if ( RUNNING_CGAL_AUTO_TEST OR CGAL_TEST_SUITE )
target_compile_options(${target} INTERFACE "-Wall")
endif()
if(CMAKE_CXX_COMPILER_VERSION VERSION_GREATER 3)
diff --git a/Installation/cmake/modules/CGAL_SetupFlags.cmake b/Installation/cmake/modules/CGAL_SetupFlags.cmake
index 514ad5c58c8..3693e29724e 100644
--- a/Installation/cmake/modules/CGAL_SetupFlags.cmake
+++ b/Installation/cmake/modules/CGAL_SetupFlags.cmake
@@ -46,7 +46,7 @@ uniquely_add_flags( CMAKE_EXE_LINKER_FLAGS_DEBUG ${CGAL_EXE_LINKER_FLAGS_DE
# Set a default build type if none is given
if ( NOT CMAKE_BUILD_TYPE )
- if( RUNNING_CGAL_AUTO_TEST )
+ if( RUNNING_CGAL_AUTO_TEST OR CGAL_TEST_SUITE )
typed_cache_set ( STRING "Build type: Release, Debug, RelWithDebInfo or MinSizeRel" CMAKE_BUILD_TYPE Debug )
else ()
typed_cache_set ( STRING "Build type: Release, Debug, RelWithDebInfo or MinSizeRel" CMAKE_BUILD_TYPE Release )
diff --git a/Installation/cmake/modules/CGAL_enable_end_of_configuration_hook.cmake b/Installation/cmake/modules/CGAL_enable_end_of_configuration_hook.cmake
index 6a792ab5c91..70716d226c2 100644
--- a/Installation/cmake/modules/CGAL_enable_end_of_configuration_hook.cmake
+++ b/Installation/cmake/modules/CGAL_enable_end_of_configuration_hook.cmake
@@ -84,7 +84,7 @@ function(CGAL_hook_check_CMAKE_BUILD_TYPE)
if(DEFINED CMAKE_BUILD_TYPE AND ( NOT CMAKE_BUILD_TYPE OR CMAKE_BUILD_TYPE STREQUAL "Debug") )
set(keyword WARNING)
set(type warning)
- if(RUNNING_CGAL_AUTO_TEST)
+ if(RUNNING_CGAL_AUTO_TEST OR CGAL_TEST_SUITE)
# No warning in the CMake test suite, but a status message
set(keyword)
set(type notice)
diff --git a/Installation/cmake/modules/FindTBB.cmake b/Installation/cmake/modules/FindTBB.cmake
index 3cbea03d9b9..8b7aa08a92b 100644
--- a/Installation/cmake/modules/FindTBB.cmake
+++ b/Installation/cmake/modules/FindTBB.cmake
@@ -43,7 +43,7 @@
#-------------------------------------------------------------------
# This file is part of the CMake build system for OGRE
# (Object-oriented Graphics Rendering Engine)
-# For the latest info, see http://www.ogre3d.org/
+# For the latest info, see https://www.ogre3d.org/
#
# The contents of this file are placed in the public domain. Feel
# free to make use of it in any way you like.
diff --git a/Installation/cmake/modules/UseCGAL.cmake b/Installation/cmake/modules/UseCGAL.cmake
index 4d44ca90219..43449b85e51 100644
--- a/Installation/cmake/modules/UseCGAL.cmake
+++ b/Installation/cmake/modules/UseCGAL.cmake
@@ -13,7 +13,7 @@ if(NOT USE_CGAL_FILE_INCLUDED)
set(USE_CGAL_FILE_INCLUDED 1)
include(${CMAKE_CURRENT_LIST_DIR}/CGAL_Common.cmake)
- if( CGAL_DEV_MODE OR RUNNING_CGAL_AUTO_TEST )
+ if( CGAL_DEV_MODE OR RUNNING_CGAL_AUTO_TEST OR CGAL_TEST_SUITE )
include(${CMAKE_CURRENT_LIST_DIR}/CGAL_SetupFlags.cmake)
else()
include(${CMAKE_CURRENT_LIST_DIR}/CGAL_display_flags.cmake)
diff --git a/Installation/doc_html/Manual/index.html b/Installation/doc_html/Manual/index.html
index ce6b70c0d9a..446d46ff910 100644
--- a/Installation/doc_html/Manual/index.html
+++ b/Installation/doc_html/Manual/index.html
@@ -1,10 +1,10 @@
-
+
CGAL - Computational Geometry Algorithms Library
-
+
diff --git a/Installation/doc_html/Manual/packages.html b/Installation/doc_html/Manual/packages.html
index ce6b70c0d9a..446d46ff910 100644
--- a/Installation/doc_html/Manual/packages.html
+++ b/Installation/doc_html/Manual/packages.html
@@ -1,10 +1,10 @@
-
+
CGAL - Computational Geometry Algorithms Library
-
+
diff --git a/Installation/doc_html/index.html b/Installation/doc_html/index.html
index 24cd53e0c23..5638303fdc9 100644
--- a/Installation/doc_html/index.html
+++ b/Installation/doc_html/index.html
@@ -1,10 +1,10 @@
-
+
CGAL - Computational Geometry Algorithms Library
-
+
@@ -19,7 +19,7 @@
-The goal of the CGAL Open Source Project is to provide
+The goal of the CGAL Open Source Project is to provide
easy access to efficient and reliable geometric algorithms
in the form of a C++ library.
@@ -36,7 +36,7 @@ You can access the CGAL Online Manual from the
@@ -46,7 +46,7 @@ You can access the CGAL Online Manual from the
CGAL is distributed under a dual-license scheme. CGAL can be used together
with Open Source software free of charge. Using CGAL in other contexts can be
done by obtaining a commercial license from
-GeometryFactory.
+GeometryFactory.
For more details see the License page.