Skip to content

Commit 2e0ec51

Browse files
slowy07Mizux
authored andcommitted
fix: typo spelling grammar
1 parent a87a10f commit 2e0ec51

Some content is hidden

Large Commits have some content hidden by default. Use the searchbox below for content that may be hidden.

45 files changed

+52
-52
lines changed

examples/dotnet/BalanceGroupSat.cs

+1-1
Original file line numberDiff line numberDiff line change
@@ -129,7 +129,7 @@ static void Main(string[] args)
129129

130130
// Compute the maximum number of colors in a group.
131131
int maxColor = numItemsPerGroup / minItemsOfSameColorPerGroup;
132-
// Redundant contraint: The problem does not solve in reasonable time
132+
// Redundant constraint: The problem does not solve in reasonable time
133133
// without it.
134134
if (maxColor < numberColors)
135135
{

examples/dotnet/csrabbitspheasants.cs

+1-1
Original file line numberDiff line numberDiff line change
@@ -42,7 +42,7 @@ public override Decision Next(Solver solver)
4242
public class CsRabbitsPheasants
4343
{
4444
/**
45-
* Solves the rabbits + pheasants problem. We are seing 20 heads
45+
* Solves the rabbits + pheasants problem. We are seeing 20 heads
4646
* and 56 legs. How many rabbits and how many pheasants are we thus
4747
* seeing?
4848
*/

ortools/bop/bop_lns.cc

+1-1
Original file line numberDiff line numberDiff line change
@@ -208,7 +208,7 @@ bool UseLinearRelaxationForSatAssignmentPreference(
208208

209209
// Note(user): We prefer to start with a really low difficulty as this works
210210
// better for large problem, and for small ones, it will be really quickly
211-
// increased anyway. Maybe a better appproach is to start by relaxing something
211+
// increased anyway. Maybe a better approach is to start by relaxing something
212212
// like 10 variables instead of having a fixed percentage.
213213
BopAdaptiveLNSOptimizer::BopAdaptiveLNSOptimizer(
214214
const std::string& name, bool use_lp_to_guide_sat,

ortools/constraint_solver/constraint_solver.h

+1-1
Original file line numberDiff line numberDiff line change
@@ -1643,7 +1643,7 @@ class Solver {
16431643
std::vector<int64_t> sinks,
16441644
std::vector<IntVar*> status);
16451645
#ifndef SWIG
1646-
/// Contraint enforcing, for each pair (i,j) in precedences, i to be before j
1646+
/// Constraint enforcing, for each pair (i,j) in precedences, i to be before j
16471647
/// in paths defined by next variables.
16481648
// TODO(user): This constraint does not make holes in variable domains;
16491649
/// the implementation can easily be modified to do that; evaluate the impact

ortools/constraint_solver/routing.h

+1-1
Original file line numberDiff line numberDiff line change
@@ -1328,7 +1328,7 @@ class RoutingModel {
13281328
const Assignment& solution_assignment, const RoutingDimension& dimension);
13291329
#endif
13301330
/// Returns the underlying constraint solver. Can be used to add extra
1331-
/// constraints and/or modify search algoithms.
1331+
/// constraints and/or modify search algorithms.
13321332
Solver* solver() const { return solver_.get(); }
13331333

13341334
/// Returns true if the search limit has been crossed.

ortools/constraint_solver/routing_search.h

+2-2
Original file line numberDiff line numberDiff line change
@@ -124,7 +124,7 @@ AutomaticFirstSolutionStrategy(bool has_pickup_deliveries,
124124
/// More details:
125125
/// Using local search filters to build a solution. The approach is pretty
126126
/// straight-forward: have a general assignment storing the current solution,
127-
/// build delta assigment representing possible extensions to the current
127+
/// build delta assignment representing possible extensions to the current
128128
/// solution and validate them with filters.
129129
/// The tricky bit comes from using the assignment and filter APIs in a way
130130
/// which avoids the lazy creation of internal hash_maps between variables
@@ -794,7 +794,7 @@ class ComparatorCheapestAdditionFilteredHeuristic
794794
/// Clarke & Wright's Savings heuristic. For each pair of nodes, the savings
795795
/// value is the difference between the cost of two routes visiting one node
796796
/// each and one route visiting both nodes. Routes are built sequentially, each
797-
/// route being initialized from the pair with the best avalaible savings value
797+
/// route being initialized from the pair with the best available savings value
798798
/// then extended by selecting the nodes with best savings on both ends of the
799799
/// partial route. Cost is based on the arc cost function of the routing model
800800
/// and cost classes are taken into account.

ortools/constraint_solver/samples/VrpInitialRoutes.cs

+1-1
Original file line numberDiff line numberDiff line change
@@ -131,7 +131,7 @@ public static void Main(String[] args)
131131
distanceDimension.SetGlobalSpanCostCoefficient(100);
132132
// [END distance_constraint]
133133

134-
// Get inital solution from routes.
134+
// Get initial solution from routes.
135135
// [START print_initial_solution]
136136
Assignment initialSolution = routing.ReadAssignmentFromRoutes(data.InitialRoutes, true);
137137
// Print initial solution on console.

ortools/constraint_solver/samples/minimal_jobshop_cp.cc

+1-1
Original file line numberDiff line numberDiff line change
@@ -69,7 +69,7 @@ void SolveJobShopExample() {
6969
}
7070
}
7171

72-
// Add conjunctive contraints.
72+
// Add conjunctive constraints.
7373
for (int i = 0; i < jobs.size(); ++i) {
7474
for (int j = 0; j < jobs[i].size() - 1; ++j) {
7575
solver.AddConstraint(solver.MakeIntervalVarRelation(

ortools/dotnet/README.md

+2-2
Original file line numberDiff line numberDiff line change
@@ -156,7 +156,7 @@ Here some dev-note concerning this `Google.OrTools.csproj`.
156156
```xml
157157
<RestoreSources>{...}/packages;$(RestoreSources)</RestoreSources>
158158
```
159-
* Add dependency (i.e. `PackageReference`) on each runtime package(s) availabe:
159+
* Add dependency (i.e. `PackageReference`) on each runtime package(s) available:
160160
```xml
161161
<ItemGroup Condition="Exists('{...}/packages/Google.OrTools.runtime.linux-x64.1.0.0.nupkg')">
162162
<PackageReference Include="Google.OrTools.runtime.linux-x64" Version="1.0.0" />
@@ -202,7 +202,7 @@ provided you have generated the three architecture dependent `Google.OrTools.run
202202
![Legend](doc/legend.svg)
203203

204204
### Building All runtime Google.OrTools Package
205-
Like in the previous scenario, on each targeted OS Platform you can build the coresponding
205+
Like in the previous scenario, on each targeted OS Platform you can build the corresponding
206206
`Google.OrTools.runtime.{rid}.nupkg` package.
207207

208208
Simply run on each platform

ortools/glop/basis_representation.h

+1-1
Original file line numberDiff line numberDiff line change
@@ -210,7 +210,7 @@ class BasisFactorization {
210210
RowIndex leaving_variable_row,
211211
const ScatteredColumn& direction);
212212

213-
// Left solves the system y.B = rhs, where y initialy contains rhs.
213+
// Left solves the system y.B = rhs, where y initially contains rhs.
214214
void LeftSolve(ScatteredRow* y) const;
215215

216216
// Left solves the system y.B = e_j, where e_j has only 1 non-zero

ortools/glop/lu_factorization.h

+1-1
Original file line numberDiff line numberDiff line change
@@ -113,7 +113,7 @@ class LuFactorization {
113113
void RightSolveLForScatteredColumn(const ScatteredColumn& b,
114114
ScatteredColumn* x) const;
115115

116-
// Specialized version of RightSolveLWithNonZeros() where x is originaly equal
116+
// Specialized version of RightSolveLWithNonZeros() where x is originally equal
117117
// to 'a' permuted by row_perm_. Note that 'a' is only used for DCHECK.
118118
void RightSolveLWithPermutedInput(const DenseColumn& a,
119119
ScatteredColumn* x) const;

ortools/glop/preprocessor.cc

+2-2
Original file line numberDiff line numberDiff line change
@@ -121,7 +121,7 @@ bool MainLpPreprocessor::Run(LinearProgram* lp) {
121121
RUN_PREPROCESSOR(SingletonColumnSignPreprocessor);
122122
}
123123

124-
// The scaling is controled by use_scaling, not use_preprocessing.
124+
// The scaling is controlled by use_scaling, not use_preprocessing.
125125
RUN_PREPROCESSOR(ScalingPreprocessor);
126126

127127
return !preprocessors_.empty();
@@ -1451,7 +1451,7 @@ bool ImpliedFreePreprocessor::Run(LinearProgram* lp) {
14511451
for (ColWithDegree col_with_degree : col_by_degree) {
14521452
const ColIndex col = col_with_degree.col;
14531453

1454-
// If the variable is alreay free or fixed, we do nothing.
1454+
// If the variable is already free or fixed, we do nothing.
14551455
const Fractional lower_bound = lp->variable_lower_bounds()[col];
14561456
const Fractional upper_bound = lp->variable_upper_bounds()[col];
14571457
if (!IsFinite(lower_bound) && !IsFinite(upper_bound)) {

ortools/glop/preprocessor.h

+1-1
Original file line numberDiff line numberDiff line change
@@ -961,7 +961,7 @@ class DualizerPreprocessor : public Preprocessor {
961961
// Example:
962962
// - A variable with bound [1e10, infinity] will be shifted to [0, infinity].
963963
// - A variable with domain [-1e10, 1e10] will not be shifted. Note that
964-
// compared to the first case, doing so here may introduce unecessary
964+
// compared to the first case, doing so here may introduce unnecessary
965965
// numerical errors if the variable value in the final solution is close to
966966
// zero.
967967
//

ortools/glop/revised_simplex.h

+1-1
Original file line numberDiff line numberDiff line change
@@ -11,7 +11,7 @@
1111
// See the License for the specific language governing permissions and
1212
// limitations under the License.
1313

14-
// Solves a Linear Programing problem using the Revised Simplex algorithm
14+
// Solves a Linear Programming problem using the Revised Simplex algorithm
1515
// as described by G.B. Dantzig.
1616
// The general form is:
1717
// min c.x where c and x are n-vectors,

ortools/glop/variables_info.h

+2-2
Original file line numberDiff line numberDiff line change
@@ -74,7 +74,7 @@ class VariablesInfo {
7474
const DenseColumn& constraint_upper_bounds);
7575

7676
// Initializes the status according to the given BasisState. Incompatible
77-
// statuses will be corrected, and we transfrom the state correctly if new
77+
// statuses will be corrected, and we transform the state correctly if new
7878
// columns / rows were added. Note however that one will need to update the
7979
// BasisState with deletions to preserve the status of unchanged columns.
8080
void InitializeFromBasisState(ColIndex first_slack, ColIndex num_new_cols,
@@ -131,7 +131,7 @@ class VariablesInfo {
131131
// I.e. they cost in the dual infeasibility minimization problem is
132132
// multiplied by 1000.
133133
//
134-
// It then update the status to get an inital dual feasible solution, and
134+
// It then update the status to get an initial dual feasible solution, and
135135
// then one just have to apply the phase II algo on this problem to try to
136136
// find a feasible solution to the original problem.
137137
//

ortools/graph/christofides.h

+1-1
Original file line numberDiff line numberDiff line change
@@ -58,7 +58,7 @@ class ChristofidesPathSolver {
5858
};
5959
ChristofidesPathSolver(NodeIndex num_nodes, CostFunction costs);
6060

61-
// Sets the matching algorith to use. A minimum weight perfect matching
61+
// Sets the matching algorithm to use. A minimum weight perfect matching
6262
// (MINIMUM_WEIGHT_MATCHING) guarantees the 3/2 upper bound to the optimal
6363
// solution. A minimal weight perfect matching (MINIMAL_WEIGHT_MATCHING)
6464
// finds a locally minimal weight matching which does not offer any bound

ortools/graph/graph.h

+2-2
Original file line numberDiff line numberDiff line change
@@ -176,7 +176,7 @@ template <typename T>
176176
class SVector;
177177

178178
// Base class of all Graphs implemented here. The default value for the graph
179-
// index types is int32_t since allmost all graphs that fit into memory do not
179+
// index types is int32_t since almost all graphs that fit into memory do not
180180
// need bigger indices.
181181
//
182182
// Note: The type can be unsigned, except for the graphs with reverse arcs
@@ -978,7 +978,7 @@ void BaseGraph<NodeIndexType, ArcIndexType,
978978
arc_capacity_ = std::max(arc_capacity_, num_arcs_);
979979
}
980980

981-
// Computes the cummulative sum of the entry in v. We only use it with
981+
// Computes the cumulative sum of the entry in v. We only use it with
982982
// in/out degree distribution, hence the Check() at the end.
983983
template <typename NodeIndexType, typename ArcIndexType, bool HasReverseArcs>
984984
void BaseGraph<NodeIndexType, ArcIndexType, HasReverseArcs>::

ortools/graph/perfect_matching.cc

+1-1
Original file line numberDiff line numberDiff line change
@@ -772,7 +772,7 @@ void BlossomGraph::Shrink(EdgeIndex e) {
772772
continue;
773773
}
774774

775-
// This is a new-internal edge that we didn't proccess yet.
775+
// This is a new-internal edge that we didn't process yet.
776776
//
777777
// TODO(user): It would be nicer to not to have to read the memory of
778778
// the other node at all. It might be possible once we store the

ortools/graph/perfect_matching.h

+1-1
Original file line numberDiff line numberDiff line change
@@ -98,7 +98,7 @@ class MinCostPerfectMatching {
9898
};
9999
ABSL_MUST_USE_RESULT Status Solve();
100100

101-
// Returns the cost of the perfect macthing. Only valid when the last solve
101+
// Returns the cost of the perfect matching. Only valid when the last solve
102102
// status was OPTIMAL.
103103
int64_t OptimalCost() const {
104104
DCHECK(optimal_solution_found_);

ortools/java/README.md

+1-1
Original file line numberDiff line numberDiff line change
@@ -93,7 +93,7 @@ So now, let's create the local `com.google.ortools:ortools-java.jar` maven
9393
package which will depend on our previous native package.
9494

9595
Here some dev-note concerning this `POM.xml`.
96-
* Add runtime dependency on each native package(s) availabe:
96+
* Add runtime dependency on each native package(s) available:
9797
```xml
9898
<dependency>
9999
<groupId>com.google.ortools</groupId>

ortools/lp_data/sparse.cc

+1-1
Original file line numberDiff line numberDiff line change
@@ -1005,7 +1005,7 @@ void TriangularMatrix::TransposeHyperSparseSolveWithReversedNonZerosInternal(
10051005
const ColIndex row_as_col = RowToColIndex(row);
10061006

10071007
// We do the loops this way so that the floating point operations are
1008-
// exactly the same as the ones perfomed by TransposeLowerSolveInternal().
1008+
// exactly the same as the ones performed by TransposeLowerSolveInternal().
10091009
EntryIndex i = starts_[row_as_col + 1] - 1;
10101010
const EntryIndex i_end = starts_[row_as_col];
10111011
for (; i >= i_end; --i) {

ortools/lp_data/sparse.h

+1-1
Original file line numberDiff line numberDiff line change
@@ -811,7 +811,7 @@ class TriangularMatrix : private CompactSparseMatrix {
811811
// can prune it and remove it from the adjacency list of the current node.
812812
//
813813
// Note(user): I couldn't find any reference for this algorithm, even though
814-
// I suspect I am not the first one to need someting similar.
814+
// I suspect I am not the first one to need something similar.
815815
mutable DenseBooleanColumn marked_;
816816

817817
// This is used to represent a pruned sub-matrix of the current matrix that

ortools/math_opt/cpp/callback.h

+1-1
Original file line numberDiff line numberDiff line change
@@ -50,7 +50,7 @@
5050
// possibly {{x, 0.0}} as well.
5151
//
5252
// If the callback argument to MathOpt::Solve() is not null, it will be invoked
53-
// on the events specificed by the callback_registration argument (and when the
53+
// on the events specified by the callback_registration argument (and when the
5454
// callback is null, callback_registration must not request any events or will
5555
// CHECK fail). Some solvers do not support callbacks or certain events, in this
5656
// case the callback is ignored. TODO(b/180617976): change this behavior.

ortools/math_opt/samples/lagrangian_relaxation.cc

+1-1
Original file line numberDiff line numberDiff line change
@@ -69,7 +69,7 @@
6969
// dualized, we can have Z_LP <= Z_D because the resulting Lagrangian subproblem
7070
// needs to be solved as an MIP. For the particular data used in this example,
7171
// dualizing only the first resource constraint leads to Z_LP < Z_D, while
72-
// dualizing only the second resurce constraint leads to Z_LP = Z_D. In either
72+
// dualizing only the second resource constraint leads to Z_LP = Z_D. In either
7373
// case, solving the Lagrandual dual also provides an upper bound to Z.
7474
//
7575
// Usage: blaze build -c opt

ortools/sat/cp_model_loader.cc

+1-1
Original file line numberDiff line numberDiff line change
@@ -696,7 +696,7 @@ void DetectOptionalVariables(const CpModelProto& model_proto, Model* m) {
696696
// of the constraints in which they appear.
697697
//
698698
// TODO(user): This deals with the simplest cases, but we could try to
699-
// detect literals that implies all the constaints in which a variable
699+
// detect literals that implies all the constraints in which a variable
700700
// appear to false. This can be done with a LCA computation in the tree of
701701
// Boolean implication (once the presolve remove cycles). Not sure if we can
702702
// properly exploit that afterwards though. Do some research!

ortools/sat/drat_proof_handler.h

+1-1
Original file line numberDiff line numberDiff line change
@@ -97,7 +97,7 @@ class DratProofHandler {
9797
// We need to keep track of the variable newly created.
9898
int variable_index_;
9999

100-
// Temporary vector used for sorting the outputed clauses.
100+
// Temporary vector used for sorting the outputted clauses.
101101
std::vector<Literal> values_;
102102

103103
// This mapping will be applied to all clause passed to AddClause() or

ortools/sat/integer.cc

+1-1
Original file line numberDiff line numberDiff line change
@@ -1864,7 +1864,7 @@ bool GenericLiteralWatcher::Propagate(Trail* trail) {
18641864
//
18651865
// TODO(user): The queue will not be emptied, but I am not sure the solver
18661866
// will be left in an usable state. Fix if it become needed to resume
1867-
// the solve from the last time it was interupted.
1867+
// the solve from the last time it was interrupted.
18681868
if (test_limit > 100) {
18691869
test_limit = 0;
18701870
if (time_limit_->LimitReached()) break;

ortools/sat/linear_programming_constraint.h

+1-1
Original file line numberDiff line numberDiff line change
@@ -319,7 +319,7 @@ class LinearProgrammingConstraint : public PropagatorInterface,
319319
// Shortcut for an integer linear expression type.
320320
using LinearExpression = std::vector<std::pair<glop::ColIndex, IntegerValue>>;
321321

322-
// Converts a dense represenation of a linear constraint to a sparse one
322+
// Converts a dense representation of a linear constraint to a sparse one
323323
// expressed in terms of IntegerVariable.
324324
void ConvertToLinearConstraint(
325325
const absl::StrongVector<glop::ColIndex, IntegerValue>& dense_vector,

ortools/sat/lp_utils.cc

+1-1
Original file line numberDiff line numberDiff line change
@@ -479,7 +479,7 @@ std::vector<double> DetectImpliedIntegers(MPModelProto* mp_model,
479479

480480
namespace {
481481

482-
// We use a class to reuse the temporay memory.
482+
// We use a class to reuse the temporary memory.
483483
struct ConstraintScaler {
484484
// Scales an individual constraint.
485485
ConstraintProto* AddConstraint(const MPModelProto& mp_model,

ortools/sat/precedences.cc

+3-3
Original file line numberDiff line numberDiff line change
@@ -282,7 +282,7 @@ void PrecedencesPropagator::AddArc(
282282
if (head == tail) {
283283
// A self-arc is either plain SAT or plain UNSAT or it forces something on
284284
// the given offset_var or presence_literal_index. In any case it could be
285-
// presolved in something more efficent.
285+
// presolved in something more efficient.
286286
VLOG(1) << "Self arc! This could be presolved. "
287287
<< "var:" << tail << " offset:" << offset
288288
<< " offset_var:" << offset_var
@@ -338,7 +338,7 @@ void PrecedencesPropagator::AddArc(
338338
// Since we add a new arc, we will need to consider its tail during the next
339339
// propagation. Note that the size of modified_vars_ will be automatically
340340
// updated when new integer variables are created since we register it with
341-
// IntegerTrail in this class contructor.
341+
// IntegerTrail in this class constructor.
342342
//
343343
// TODO(user): Adding arcs and then calling Untrail() before Propagate()
344344
// will cause this mecanism to break. Find a more robust implementation.
@@ -622,7 +622,7 @@ void PrecedencesPropagator::AnalyzePositiveCycle(
622622
// minimize the number of integer_trail_->Enqueue() as much as possible.
623623
//
624624
// TODO(user): The current algorithm is quite efficient, but there is probably
625-
// still room for improvments.
625+
// still room for improvements.
626626
bool PrecedencesPropagator::BellmanFordTarjan(Trail* trail) {
627627
const int num_nodes = impacted_arcs_.size();
628628

ortools/sat/presolve_util.cc

+1-1
Original file line numberDiff line numberDiff line change
@@ -187,7 +187,7 @@ void SubstituteVariable(int var, int64_t var_coeff_in_definition,
187187
CHECK(RefIsPositive(var));
188188
CHECK_EQ(std::abs(var_coeff_in_definition), 1);
189189

190-
// Copy all the terms (except the one refering to var).
190+
// Copy all the terms (except the one referring to var).
191191
std::vector<std::pair<int, int64_t>> terms;
192192
int64_t var_coeff = GetVarCoeffAndCopyOtherTerms(var, ct->linear(), &terms);
193193

ortools/sat/sat_parameters.proto

+1-1
Original file line numberDiff line numberDiff line change
@@ -1014,7 +1014,7 @@ message SatParameters {
10141014
// specify continuous variable domain with the wanted precision.
10151015
optional double mip_var_scaling = 125 [default = 1.0];
10161016

1017-
// If true, some continuous variable might be automatially scaled. For now,
1017+
// If true, some continuous variable might be automatically scaled. For now,
10181018
// this is only the case where we detect that a variable is actually an
10191019
// integer multiple of a constant. For instance, variables of the form k * 0.5
10201020
// are quite frequent, and if we detect this, we will scale such variable

ortools/sat/sat_solver.cc

+1-1
Original file line numberDiff line numberDiff line change
@@ -1382,7 +1382,7 @@ void SatSolver::BumpClauseActivity(SatClause* clause) {
13821382
// This one is similar to the one used by the Glucose SAT solver.
13831383
//
13841384
// TODO(user): why the +1? one reason may be that the LBD of a conflict
1385-
// decrease by 1 just afer the backjump...
1385+
// decrease by 1 just after the backjump...
13861386
if (new_lbd + 1 < it->second.lbd) {
13871387
it->second.protected_during_next_cleanup = true;
13881388
it->second.lbd = new_lbd;

ortools/sat/simplification.cc

+1-1
Original file line numberDiff line numberDiff line change
@@ -381,7 +381,7 @@ void SatPresolver::PresolveWithBva() {
381381
}
382382
}
383383

384-
// We use the same notation as in the article mentionned in the .h
384+
// We use the same notation as in the article mentioned in the .h
385385
void SatPresolver::SimpleBva(LiteralIndex l) {
386386
literal_to_p_size_.resize(literal_to_clauses_.size(), 0);
387387
DCHECK(std::all_of(literal_to_p_size_.begin(), literal_to_p_size_.end(),

ortools/sat/timetable.cc

+1-1
Original file line numberDiff line numberDiff line change
@@ -378,7 +378,7 @@ bool TimeTablingPerTask::BuildProfile() {
378378
// Add a sentinel to simplify the algorithm.
379379
profile_.emplace_back(kMinIntegerValue, IntegerValue(0));
380380

381-
// Start and height of the currently built profile rectange.
381+
// Start and height of the currently built profile rectangle.
382382
IntegerValue current_start = kMinIntegerValue;
383383
IntegerValue current_height = starting_profile_height_;
384384

ortools/util/affine_relation.h

+1-1
Original file line numberDiff line numberDiff line change
@@ -157,7 +157,7 @@ class AffineRelation {
157157
//
158158
// TODO(user): Using a "rank" might be faster, but because we sometimes
159159
// need to merge the bad subtree into the better one, it is trickier to
160-
// maintain than in the classic union-find algorihtm.
160+
// maintain than in the classic union-find algorithm.
161161
std::vector<int> size_;
162162

163163
// Used by CompressPath() to maintain the coeff/offset during compression.

ortools/util/bitset.h

+1-1
Original file line numberDiff line numberDiff line change
@@ -736,7 +736,7 @@ class BitQueue64 {
736736

737737
// Note(user): I experimented with reversing the bit order in a bucket to
738738
// use LeastSignificantBitPosition64() and it is only slightly faster at the
739-
// cost of a lower Set() speed. So I prefered this version.
739+
// cost of a lower Set() speed. So I preferred this version.
740740
top_ = static_cast<int>(BitShift64(bucket_index) +
741741
MostSignificantBitPosition64(bucket));
742742
}

0 commit comments

Comments
 (0)