Skip to content

Commit

Permalink
Merge pull request CGAL#8246 from albert-github/feature/bug_spell_202…
Browse files Browse the repository at this point in the history
…40531

Spelling corrections
  • Loading branch information
sloriot committed Jun 5, 2024
2 parents 2c13f1f + 36c8b75 commit c3596fc
Show file tree
Hide file tree
Showing 134 changed files with 182 additions and 182 deletions.
Original file line number Diff line number Diff line change
Expand Up @@ -575,13 +575,13 @@ If the `UsePolylines` template parameter is substitited with

<li>Instead of using an instance of the `Polygon_set_2` class
template, as described above, an instance of the
`General_polygon_set_2` class template is used, which utilzes the
`General_polygon_set_2` class template is used, which utilizes the
`Arr_polyline_traits_2` class template; see Section \ref
arr_ssectr_polylines in the 2D Arrangements package.

<li>Each input linear polygon (respectively linear polygon with holes) is
converted into a general polygon (respectively general polygon with holes)
bounded by \f$x\f$-monotone polylines. Then, the resulting generl
bounded by \f$x\f$-monotone polylines. Then, the resulting general
polygons, which are also bounded by \f$x\f$-monotone polylines, are
converted back to standard polygons.

Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -691,7 +691,7 @@ bool are_holes_and_boundary_pairwise_disjoint
bool intersect = gps.do_intersect(hole);
if (intersect) return false;
else {
/* to use gps.insert(hole) it is required that the set coponents and the
/* to use gps.insert(hole) it is required that the set components and the
* new holes do not intersect.
* because the sweep detects shared edges and the do_intersect query
* detects 2D intersections we can safely use the insert(pwh) function
Expand Down
2 changes: 1 addition & 1 deletion Boolean_set_operations_2/include/CGAL/connect_holes.h
Original file line number Diff line number Diff line change
Expand Up @@ -48,7 +48,7 @@ struct _Less_handle

/*!
* Connect the given polygon with holes, turning it into a sequence of
* points, where the holes are connceted to the outer boundary using
* points, where the holes are connected to the outer boundary using
* zero-width passages.
* For example:
* Input Output
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -195,7 +195,7 @@ namespace CGAL {
// where alpha = (1+a_eps)(d+1) with a_eps the return value
// of achieved_epsilon().
//
// The ellipsoid E* we actuallly want is the intersection of E' with
// The ellipsoid E* we actually want is the intersection of E' with
// the hyperplane { (y,z) in R^{d+1} | y = 1}. Writing
//
// [ M' m ] [ y ]
Expand Down
22 changes: 11 additions & 11 deletions Bounding_volumes/include/CGAL/pierce_rectangles_2.h
Original file line number Diff line number Diff line change
Expand Up @@ -794,7 +794,7 @@ four_cover_points(Staircases< Traits >& d, OutputIterator o, bool& ok)
if (d.is_middle_empty()) {

// now try to position the bottom piercing point in each
// of the intervalls formed by S_bt and S_br
// of the intervals formed by S_bt and S_br
// (no need to consider S_bl, since we move from left
// to right and leaving a rectangle won't make piercing easier)

Expand All @@ -813,7 +813,7 @@ four_cover_points(Staircases< Traits >& d, OutputIterator o, bool& ok)
Citerator br = d.brstc_begin();
Citerator rt = d.rtstc_begin();

// make sure the top intervall is covered (left endpoint)
// make sure the top interval is covered (left endpoint)
// (it might be that top_i.first determines the placement of
// the top square)
Point_2 top = top_i.first;
Expand All @@ -826,14 +826,14 @@ four_cover_points(Staircases< Traits >& d, OutputIterator o, bool& ok)
if (tl != d.tlstc_end()) {
for (;;) {

// make sure the top intervall is covered (right endpoint)
// make sure the top interval is covered (right endpoint)
if (sdistx(top_i.second, top) > FT(2) * d.r)
break;

// compute position of left square
Point_2 left = lessy(left_i.second, *tl) ? *tl : left_i.second;

// make sure the left intervall is covered
// make sure the left interval is covered
if (sdisty(left, left_i.first) <= FT(2) * d.r) {

// compute position of bottom square
Expand All @@ -844,7 +844,7 @@ four_cover_points(Staircases< Traits >& d, OutputIterator o, bool& ok)
break;
Point_2 bottom = lessx(bottom_i.first, *lb) ? bottom_i.first : *lb;

// check the shared x-intervall
// check the shared x-interval
if (!share.empty() && d.is_x_greater_y()) {
// compute position of top in share
#ifndef _MSC_VER
Expand All @@ -862,7 +862,7 @@ four_cover_points(Staircases< Traits >& d, OutputIterator o, bool& ok)
sdistx(*(shl - 1), top) > FT(2) * d.r)
--shl;

// make sure shared intervall is covered (left endpoint)
// make sure shared interval is covered (left endpoint)
#ifndef _MSC_VER
if ((shf != share.begin() || shl == share.end()) &&
lessx(share.front(), bottom))
Expand All @@ -881,7 +881,7 @@ four_cover_points(Staircases< Traits >& d, OutputIterator o, bool& ok)
}


// make sure the bottom and the shared intervall (right endpoint)
// make sure the bottom and the shared interval (right endpoint)
// are covered
#ifndef _MSC_VER
if (sdistx(bottom_i.second, bottom) <= FT(2) * d.r &&
Expand All @@ -907,7 +907,7 @@ four_cover_points(Staircases< Traits >& d, OutputIterator o, bool& ok)
break;
Point_2 right = lessy(right_i.first, *br) ? right_i.first : *br;

// check the shared y-intervall
// check the shared y-interval
if (!share.empty() && !d.is_x_greater_y()) {
// compute position of left in share
#ifndef _MSC_VER
Expand All @@ -926,7 +926,7 @@ four_cover_points(Staircases< Traits >& d, OutputIterator o, bool& ok)
lessy(left, *(shl - 1)))
--shl;

// make sure shared intervall is covered (bottom endpoint)
// make sure shared interval is covered (bottom endpoint)
#ifndef _MSC_VER
if ((shf != share.begin() || shl == share.end()) &&
lessy(share.front(), right))
Expand All @@ -945,7 +945,7 @@ four_cover_points(Staircases< Traits >& d, OutputIterator o, bool& ok)
}


// make sure the right intervall and the shared intervall
// make sure the right interval and the shared interval
// (top endpoint) are covered
#ifndef _MSC_VER
if (sdisty(right_i.second, right) <= FT(2) * d.r &&
Expand Down Expand Up @@ -985,7 +985,7 @@ four_cover_points(Staircases< Traits >& d, OutputIterator o, bool& ok)

} // if (sdisty(right_i.second, right) <= FT(2) * d.r)

} // if (bottom and shared intervall are covered)
} // if (bottom and shared interval are covered)

} // if (sdisty(left, left_i.first) <= FT(2) * d.r)

Expand Down
2 changes: 1 addition & 1 deletion CGAL_Core/include/CGAL/CORE/BigFloat.h
Original file line number Diff line number Diff line change
Expand Up @@ -332,7 +332,7 @@ class CGAL_CORE_EXPORT BigFloat : public RCBigFloat {
return rep->clLgErr();
}

/// division with relative precsion <tt>r</tt>
/// division with relative precision <tt>r</tt>
BigFloat div(const BigFloat& x, const extLong& r) const {
BigFloat y;
y.rep->div(*rep, *x.rep, r);
Expand Down
2 changes: 1 addition & 1 deletion CGAL_Core/include/CGAL/CORE/Filter.h
Original file line number Diff line number Diff line change
Expand Up @@ -92,7 +92,7 @@ class filteredFp {
CGAL_CORE_finite(fpVal) && // Test for infinite and NaNs
(core_abs(fpVal) >= maxAbs*ind*CORE_EPS));
}
/// return the sign of fitered value.
/// return the sign of filtered value.
/** (Note: must call isOK() to check whether the sign is ok
before call this function.) */
int sign() const {
Expand Down
2 changes: 1 addition & 1 deletion CGAL_ipelets/demo/CGAL_ipelets/nearest_neighbor_graph.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -68,7 +68,7 @@ void nngIpelet::protected_run(int fn)
++v){

std::vector<Triangulation::Vertex_handle> kNN;
CGAL::nearest_neighbors(t, v, kNeighbors+1, std::back_inserter(kNN)); // +1 as v itself counts as its nearest neigbhor for CGAL::nearest_neighbors
CGAL::nearest_neighbors(t, v, kNeighbors+1, std::back_inserter(kNN)); // +1 as v itself counts as its nearest neighbor for CGAL::nearest_neighbors

for(const auto & nn : kNN) {
if(v->point() != nn->point()) {
Expand Down
2 changes: 1 addition & 1 deletion Cartesian_kernel/TODO
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@ Stuff to look at, as time permits:

- Why Ray_3 and Line_3 don't have the same internal representation ???

- Triangle-Triangle instersection (and predicate) :
- Triangle-Triangle intersection (and predicate) :
Tomas Möller. A fast triangle-triangle intersection test. Journal of
Graphics Tools, 2(2):25-30, 1997
A Fast Triangle-Triangle Intersection Test, tompa@clarus.se
Expand Down
2 changes: 1 addition & 1 deletion Circular_kernel_2/benchmark/arrangement_traits/benchmark.h
Original file line number Diff line number Diff line change
Expand Up @@ -210,7 +210,7 @@ class Bench
Pmwx _pm;
Point_location _pl(_pm);

std::cout << "Construction complited"<<std::endl;
std::cout << "Construction completed"<<std::endl;
try{
this->start();

Expand Down
2 changes: 1 addition & 1 deletion Circular_kernel_2/benchmark/bff_reader/readme.txt
Original file line number Diff line number Diff line change
@@ -1,6 +1,6 @@
It's not finished reader off .bff it uses extended version of
parser. I hope it will be useful for yours future works. By using
this source you can easyly create yours own.
this source you can easily create yours own.

missing
Circular-arc
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -212,7 +212,7 @@ class Bench
Pmwx _pm;
Point_location _pl(_pm);

std::cout << "Construction complited"<<std::endl;
std::cout << "Construction completed"<<std::endl;
try{
this->start();
for (typename ArcContainer::const_iterator it=ac.begin();
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -1453,7 +1453,7 @@ template < class CK, class OutputIterator >
// returns extra information, descriptive of the position of the returned
// xy-monotone arcs on the circle: The output iterator refers to pairs, the
// first part of which is the object containing the arc and the second part
// is another pair containing 2 booleans which equavalently describe whether the
// is another pair containing 2 booleans which equivalently describe whether the
// returned xy-monotone arc is on the upper part and the left side of the circle

template < typename CK , typename Output_iterator>
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -15,8 +15,8 @@ int main() {
CGAL::Random theRandom(random_seed);
int count = 0;

std::cout << "We will compute the approximate probability that 3 spheres wit"
<< "h radius 1 intersect on a 5x5x5 box, it might take some time." << std::endl;
std::cout << "We will compute the approximate probability that 3 spheres with"
<< " radius 1 intersect on a 5x5x5 box, it might take some time." << std::endl;

for(int i=0; i<10000; i++) {

Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -470,7 +470,7 @@ int main (int argc, char** argv)
}
}

// Fill all holes except the bigest (which is the outer hull of the mesh)
// Fill all holes except the biggest (which is the outer hull of the mesh)
for (Mesh::Halfedge_index hi : holes)
if (hi != outer_hull)
CGAL::Polygon_mesh_processing::triangulate_refine_and_fair_hole
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -100,7 +100,7 @@ class Plane_scan_tree {
: less (comp), vless (vcomp), root (nullptr), m_min (nullptr),
m_max (nullptr), _size (0)
{
// buids the tree
// builds the tree
/* Note: a more efficient algorithm building the tree bottom up may be
worth implementing later */
for (; first != last; ++first)
Expand Down
2 changes: 1 addition & 1 deletion Convex_hull_d/doc/Convex_hull_d/CGAL/Convex_hull_d.h
Original file line number Diff line number Diff line change
Expand Up @@ -352,7 +352,7 @@ void print_statistics() ;

/*!
checks the
validity of the data structure. If `throw_exceptions == thrue`
validity of the data structure. If `throw_exceptions == true`
then the program throws the following exceptions to inform about the
problem.
`chull_has_center_on_wrong_side_of_hull_facet` the
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -144,7 +144,7 @@ shared with other `My_geo_object` objects.

\section Developer_manualTemplatedhandles Templated handles

Factoring out the common functionality in base classes enables re-use of
Factoring out the common functionality in base classes enables reuse of
the code, but there is also a major drawback. The `Handle` class does not
know the type of the representation object. It maintains a `Rep*` pointer.
Therefore, this pointer must be cast to a pointer to the actual type
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -92,7 +92,7 @@ the same object with opposite orientation.

For a number of predicates, there are versions that operate on
the coordinates directly, not on the geometric objects. These
number-type based predicates ease re-use with non-<em>CGAL</em> types.
number-type based predicates ease reuse with non-<em>CGAL</em> types.

\section secNewKernelTraits Missing functionality

Expand All @@ -103,7 +103,7 @@ with a different API, then one should really implement the
functionality and the others call that one.

Whenever you need a predicate that is not present in the current kernel
traits, you should first try to re-use the available predicates (you
traits, you should first try to reuse the available predicates (you
might rewrite the code or implement the new predicate using existing ones).
If this is not feasible (especially for efficiency reasons), we have to
decide on adding the new predicate to the kernel traits.
Expand Down
2 changes: 1 addition & 1 deletion Documentation/doc/Documentation/Getting_started.txt
Original file line number Diff line number Diff line change
Expand Up @@ -7,7 +7,7 @@ The following pages describe how to use \cgal on different environments:

- \subpage windows

- \subpage thirdparty gives information (supported versions, download links) of the required and optional third party libraries.
- \subpage thirdparty gives information (supported versions, download links) of the required and optional third-party libraries.

- \subpage devman_create_and_use_a_cmakelist explains how to use CMake to link a program with \cgal.

Expand Down
2 changes: 1 addition & 1 deletion Envelope_3/doc/Envelope_3/CGAL/Env_triangle_traits_3.h
Original file line number Diff line number Diff line change
Expand Up @@ -24,7 +24,7 @@ namespace CGAL {
* two triangles, onto the \f$ xy\f$-plane, we obtain line segments. Indeed,
* `Env_triangle_traits_3` inherits from the traits class that substitutes
* `ArrSegmentTraits`, and extends it by adding operations on 3D objects, namely
* spacial triangles. Note that the traits class does <I>not</I> define
* spatial triangles. Note that the traits class does <I>not</I> define
* `Kernel::Triangle_3` as its surface (and \f$ xy\f$-monotone surface) type, as
* one may expect. This is because the traits class needs to store extra data
* with the triangles in order to efficiently operate on them. Nevertheless,
Expand Down
4 changes: 2 additions & 2 deletions Envelope_3/doc/Envelope_3/Envelope_3.txt
Original file line number Diff line number Diff line change
Expand Up @@ -97,9 +97,9 @@ of planar arrangements, the `EnvelopeTraits_3` refines the
concept must define the planar types `Point_2` and
`X_monotone_curve_2` and support basic operations on them, as
listed in Section \ref aos_sec-geom_traits. Moreover, it must define the
spacial types `Surface_3` and `Xy_monotone_surface_3` (in practice,
spatial types `Surface_3` and `Xy_monotone_surface_3` (in practice,
these two types may be the same). Any model of the envelope-traits
concept must also support the following operations on these spacial
concept must also support the following operations on these spatial
types:

\cgalFigureAnchor{env3_figcomp_over}
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -2067,7 +2067,7 @@ class Envelope_element_visitor_3 {
v2_is_new = true;
}

// now use the approppriate method to insert the new edge
// now use the appropriate method to insert the new edge
if (v1_is_new && v2_is_new) {
// if both vertices are new - use the O(1) operation
// _insert_in_face_interior (in the face mapped to by he->face())
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -311,7 +311,7 @@ class Envelope_overlay_functor {
Halfedge_handle hh = vc;
// update the map
traversed_vertices[Vertex_face_pair(v, hh->face())] = hh;
// check for reult
// check for result
if (hh->face() == f) result = hh;
} while (++vc != vc_begin);
}
Expand Down
2 changes: 1 addition & 1 deletion Filtered_kernel/TODO
Original file line number Diff line number Diff line change
Expand Up @@ -166,7 +166,7 @@ class Filtered_Point_2
#endif
};

// For filtered constructions, we should be able to re-use the same predicates,
// For filtered constructions, we should be able to reuse the same predicates,
// but have different constructions and objects Point_2...
template <class EK, class IK = Cartesian<Interval> >
class Filtered_kernel
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -84,7 +84,7 @@
// - others ?
// - benchmark on more algorithms.
// - improve fit_in_double() for other NTs (MP_Float, Lazy). cf tools.h.
// - try to automatize : have a struct a la Static_filter_error, with one part
// - try to automate : have a struct a la Static_filter_error, with one part
// which is runtime, and the other which can be constant-propagated by the
// compiler. g++ 4.0 should be able to cprop the second part...

Expand Down
2 changes: 1 addition & 1 deletion Generator/examples/Generator/README
Original file line number Diff line number Diff line change
Expand Up @@ -45,7 +45,7 @@ ball_d.cpp
generates random points within an hyper ball in dim d.

cube_d.cpp
generates random points wthin an hyper cube in dim d.
generates random points within an hyper cube in dim d.

grid_d.cpp
generates points on a grid in dim d.
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -115,7 +115,7 @@ class L1_voronoi_traits_2 : public Arr_linear_traits_2<Kernel_>

if (l.is_vertical()) {
// Could be a tie.
// To be "above" the curve, we acutually need to have smaller x coordinate,
// To be "above" the curve, we actually need to have smaller x coordinate,
// the order of the comparison function here is opposite to the none vertical
// case.
side = CGAL::opposite(side);
Expand Down
2 changes: 1 addition & 1 deletion GraphicsView/include/CGAL/Qt/camera_impl.h
Original file line number Diff line number Diff line change
Expand Up @@ -155,7 +155,7 @@ since the latter automatically updates these values when it is resized (hence
overwriting your values).
Non-positive dimension are silently replaced by a 1 pixel value to ensure
frustrum coherence.
frustum coherence.
If your Camera is used without a CGAL::QGLViewer (offscreen rendering, shadow maps),
use setAspectRatio() instead to define the projection matrix. */
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -189,7 +189,7 @@ namespace HomogeneousKernelFunctors {
// want to solve alpha*v1 + beta*v2 + gamma*v3 == vp
// let vi' == vi*vi.hw()
// we solve alpha'*v1' + beta'*v2' + gamma'*v3' == vp' / vp.hw()
// muliplied by vp.hw()
// multiplied by vp.hw()
// then we have alpha = alpha'*v1.hw() / vp.hw()
// and beta = beta' *v2.hw() / vp.hw()
// and gamma = gamma'*v3.hw() / vp.hw()
Expand Down
2 changes: 1 addition & 1 deletion Hyperbolic_triangulation_2/TODO
Original file line number Diff line number Diff line change
Expand Up @@ -17,7 +17,7 @@ understand why

remove variant for supporting circle or line of bisector
call it only when we know that it is a circle
it will simplyfy the code of Construct_hyperbolic_bisector_2 at least in some cases
it will simplify the code of Construct_hyperbolic_bisector_2 at least in some cases

test bisectors dual functions in special cases of euclidean line segments

Expand Down
2 changes: 1 addition & 1 deletion Installation/CHANGES.md
Original file line number Diff line number Diff line change
Expand Up @@ -4933,7 +4933,7 @@ CGAL now works around the preprocessor macros 'min' and 'max' defined in
allows users to extend the DCEL of the underlying arrangement.
- Added a function template called connect\_holes() that connects
the holes in a given polygon with holes, turning it into a
sequence of points, where the holes are connceted to the outer
sequence of points, where the holes are connected to the outer
boundary using zero-width passages.
- Added a non-const function member to General\_polygon\_set\_2
that obtains the underlying arrangement.
Expand Down
Loading

0 comments on commit c3596fc

Please sign in to comment.