28#include "absl/container/flat_hash_set.h"
29#include "absl/log/check.h"
30#include "absl/numeric/bits.h"
31#include "absl/types/span.h"
46#include "ortools/sat/sat_parameters.pb.h"
58IntegerVariable CreateVariableWithTightDomain(
59 absl::Span<const AffineExpression> exprs,
Model* model) {
62 auto* integer_trail = model->GetOrCreate<
IntegerTrail>();
64 min = std::min(min, integer_trail->LevelZeroLowerBound(e));
65 max = std::max(max, integer_trail->LevelZeroUpperBound(e));
70IntegerVariable CreateVariableAtOrAboveMinOf(
71 absl::Span<const AffineExpression> exprs,
Model* model) {
72 const IntegerVariable var = CreateVariableWithTightDomain(exprs, model);
73 auto* constraint =
new MinPropagator({exprs.begin(), exprs.end()}, var,
76 model->TakeOwnership(constraint);
81IntegerVariable CreateVariableAtOrBelowMaxOf(
82 absl::Span<const AffineExpression> exprs,
Model* model) {
83 std::vector<AffineExpression> negated_exprs(exprs.begin(), exprs.end());
86 const IntegerVariable var =
87 CreateVariableWithTightDomain(negated_exprs, model);
88 auto* constraint =
new MinPropagator(std::move(negated_exprs), var,
91 model->TakeOwnership(constraint);
105 const IntegerVariable min_start_var =
106 CreateVariableAtOrAboveMinOf(y->Starts(), model);
107 const IntegerVariable max_end_var =
108 CreateVariableAtOrBelowMaxOf(y->Ends(), model);
110 auto* integer_trail = model->GetOrCreate<
IntegerTrail>();
111 if (integer_trail->UpperBound(max_end_var) <
112 integer_trail->LowerBound(min_start_var)) {
119 0,
CapSub(integer_trail->UpperBound(max_end_var).value(),
120 integer_trail->LowerBound(min_start_var).value()))));
121 const std::vector<int64_t> coeffs = {-capacity.coeff.value(), -1, 1};
124 coeffs, capacity.constant.value()));
133 const SatParameters& params = *model->GetOrCreate<SatParameters>();
134 if (params.use_timetabling_in_no_overlap_2d()) {
138 model->TakeOwnership(time_tabling);
143 if (params.use_energetic_reasoning_in_no_overlap_2d()) {
151 const std::vector<IntervalVariable>& y,
174 const SatParameters& params = *model->
GetOrCreate<SatParameters>();
175 const bool add_cumulative_relaxation =
176 params.use_timetabling_in_no_overlap_2d() ||
177 params.use_energetic_reasoning_in_no_overlap_2d();
179 if (add_cumulative_relaxation) {
184 bool some_boxes_are_only_optional_on_x =
false;
185 bool some_boxes_are_only_optional_on_y =
false;
186 for (
int i = 0;
i < x.size(); ++
i) {
195 some_boxes_are_only_optional_on_x =
true;
200 some_boxes_are_only_optional_on_y =
true;
203 if (!some_boxes_are_only_optional_on_y) {
204 AddDiffnCumulativeRelationOnX(x_helper, y_helper, model);
206 if (!some_boxes_are_only_optional_on_x) {
207 AddDiffnCumulativeRelationOnX(y_helper, x_helper, model);
211 if (params.use_area_energetic_reasoning_in_no_overlap_2d()) {
220 if (params.use_try_edge_reasoning_in_no_overlap_2d()) {
225#define RETURN_IF_FALSE(f) \
226 if (!(f)) return false;
230 if (!VLOG_IS_ON(1))
return;
231 std::vector<std::pair<std::string, int64_t>> stats;
233 {
"NonOverlappingRectanglesEnergyPropagator/called", num_calls_});
235 {
"NonOverlappingRectanglesEnergyPropagator/conflicts", num_conflicts_});
237 {
"NonOverlappingRectanglesEnergyPropagator/conflicts_two_boxes",
238 num_conflicts_two_boxes_});
239 stats.push_back({
"NonOverlappingRectanglesEnergyPropagator/refined",
240 num_refined_conflicts_});
242 {
"NonOverlappingRectanglesEnergyPropagator/conflicts_with_slack",
243 num_conflicts_with_slack_});
245 shared_stats_->AddStats(stats);
250 const int num_boxes = helper_.NumBoxes();
251 if (!helper_.SynchronizeAndSetDirection())
return false;
253 Rectangle bounding_box = {.x_min = std::numeric_limits<IntegerValue>::max(),
254 .x_max = std::numeric_limits<IntegerValue>::min(),
255 .y_min = std::numeric_limits<IntegerValue>::max(),
256 .y_max = std::numeric_limits<IntegerValue>::min()};
257 std::vector<RectangleInRange> active_box_ranges;
258 active_box_ranges.reserve(num_boxes);
259 for (
int box = 0; box < num_boxes; ++box) {
260 if (!helper_.IsPresent(box))
continue;
264 active_box_ranges.push_back(std::move(rec));
267 if (active_box_ranges.size() < 2) {
272 if (active_box_ranges.size() > 1000) {
276 if (std::max(bounding_box.
SizeX(), bounding_box.
SizeY()) *
277 active_box_ranges.size() >
278 std::numeric_limits<int32_t>::max()) {
286 std::optional<Conflict> best_conflict =
287 FindConflict(std::move(active_box_ranges));
288 if (!best_conflict.has_value()) {
297 IntegerValue best_explanation_size =
298 best_conflict->opp_result.GetItemsParticipatingOnConflict().size();
299 bool refined =
false;
301 std::vector<RectangleInRange> items_participating_in_conflict;
302 items_participating_in_conflict.reserve(
303 best_conflict->items_for_opp.size());
304 for (
const auto& item :
305 best_conflict->opp_result.GetItemsParticipatingOnConflict()) {
306 items_participating_in_conflict.push_back(
307 best_conflict->items_for_opp[item.index]);
309 std::optional<Conflict> conflict =
310 FindConflict(items_participating_in_conflict);
311 if (!conflict.has_value())
break;
313 if (conflict->opp_result.GetItemsParticipatingOnConflict().size() >=
314 best_explanation_size) {
318 best_explanation_size =
319 conflict->opp_result.GetItemsParticipatingOnConflict().size();
320 best_conflict = std::move(conflict);
324 num_refined_conflicts_ += refined;
325 const std::vector<RectangleInRange> generalized_explanation =
326 GeneralizeExplanation(*best_conflict);
327 if (best_explanation_size == 2) {
328 num_conflicts_two_boxes_++;
330 helper_.ReportConflictFromInfeasibleBoxRanges(generalized_explanation);
334std::optional<NonOverlappingRectanglesEnergyPropagator::Conflict>
335NonOverlappingRectanglesEnergyPropagator::FindConflict(
336 std::vector<RectangleInRange> active_box_ranges) {
337 const auto rectangles_with_too_much_energy =
340 if (rectangles_with_too_much_energy.conflicts.empty() &&
341 rectangles_with_too_much_energy.candidates.empty()) {
345 Conflict best_conflict;
351 constexpr int kSampleSize = 10;
352 absl::InlinedVector<Rectangle, kSampleSize> sampled_rectangles;
353 std::sample(rectangles_with_too_much_energy.conflicts.begin(),
354 rectangles_with_too_much_energy.conflicts.end(),
355 std::back_inserter(sampled_rectangles), 5, *random_);
356 std::sample(rectangles_with_too_much_energy.candidates.begin(),
357 rectangles_with_too_much_energy.candidates.end(),
358 std::back_inserter(sampled_rectangles),
359 kSampleSize - sampled_rectangles.size(), *random_);
360 std::sort(sampled_rectangles.begin(), sampled_rectangles.end(),
361 [](
const Rectangle& a,
const Rectangle&
b) {
362 const bool larger = std::make_pair(a.SizeX(), a.SizeY()) >
363 std::make_pair(b.SizeX(), b.SizeY());
369 DCHECK(a.x_min <= b.x_min && a.x_max >= b.x_max &&
370 a.y_min <= b.y_min && a.y_max >= b.y_max);
373 DCHECK(a.x_min >= b.x_min && a.x_max <= b.x_max &&
374 a.y_min >= b.y_min && a.y_max <= b.y_max);
378 std::vector<IntegerValue> sizes_x, sizes_y;
379 sizes_x.reserve(active_box_ranges.size());
380 sizes_y.reserve(active_box_ranges.size());
381 std::vector<RectangleInRange> filtered_items;
382 filtered_items.reserve(active_box_ranges.size());
383 for (
const Rectangle& r : sampled_rectangles) {
386 filtered_items.clear();
387 for (
int i = 0;
i < active_box_ranges.size(); ++
i) {
388 const RectangleInRange& box = active_box_ranges[
i];
389 const Rectangle intersection = box.GetMinimumIntersection(r);
390 if (intersection.SizeX() > 0 && intersection.SizeY() > 0) {
391 sizes_x.push_back(intersection.SizeX());
392 sizes_y.push_back(intersection.SizeY());
393 filtered_items.push_back(box);
400 const auto opp_result = orthogonal_packing_checker_.TestFeasibility(
401 sizes_x, sizes_y, {r.SizeX(), r.SizeY()},
403 .use_pairwise =
true,
406 .brute_force_threshold = 7,
407 .dff2_max_number_of_parameters_to_check = 100});
409 (best_conflict.opp_result.GetResult() !=
411 best_conflict.opp_result.GetItemsParticipatingOnConflict().size() >
412 opp_result.GetItemsParticipatingOnConflict().size())) {
413 best_conflict.items_for_opp = filtered_items;
414 best_conflict.opp_result = opp_result;
415 best_conflict.rectangle_with_too_much_energy = r;
419 filtered_items.swap(active_box_ranges);
421 if (best_conflict.opp_result.GetResult() ==
423 return best_conflict;
429std::vector<RectangleInRange>
430NonOverlappingRectanglesEnergyPropagator::GeneralizeExplanation(
431 const Conflict& conflict) {
432 const Rectangle& rectangle = conflict.rectangle_with_too_much_energy;
433 OrthogonalPackingResult relaxed_result = conflict.opp_result;
436 int used_slack_count = 0;
437 const auto& items = relaxed_result.GetItemsParticipatingOnConflict();
438 for (
int i = 0;
i < items.size(); ++
i) {
439 if (!relaxed_result.HasSlack()) {
442 const RectangleInRange& range = conflict.items_for_opp[items[
i].index];
443 const RectangleInRange item_in_zero_level_range = {
445 {.x_min = helper_.x_helper().LevelZeroStartMin(range.box_index),
446 .x_max = helper_.x_helper().LevelZeroStartMax(range.box_index) +
448 .y_min = helper_.y_helper().LevelZeroStartMin(range.box_index),
449 .y_max = helper_.y_helper().LevelZeroStartMax(range.box_index) +
451 .x_size = range.x_size,
452 .y_size = range.y_size};
455 const Rectangle max_overlap =
456 item_in_zero_level_range.GetMinimumIntersection(rectangle);
457 used_slack_count += relaxed_result.TryUseSlackToReduceItemSize(
458 i, OrthogonalPackingResult::Coord::kCoordX, max_overlap.SizeX());
459 used_slack_count += relaxed_result.TryUseSlackToReduceItemSize(
460 i, OrthogonalPackingResult::Coord::kCoordY, max_overlap.SizeY());
462 num_conflicts_with_slack_ += (used_slack_count > 0);
463 VLOG_EVERY_N_SEC(2, 3)
464 <<
"Found a conflict on the OPP sub-problem of rectangle: " << rectangle
466 << conflict.opp_result.GetItemsParticipatingOnConflict().size() <<
"/"
467 << conflict.items_for_opp.size() <<
" items.";
469 std::vector<RectangleInRange> ranges_for_explanation;
470 ranges_for_explanation.reserve(conflict.items_for_opp.size());
471 std::vector<OrthogonalPackingResult::Item> sorted_items =
472 relaxed_result.GetItemsParticipatingOnConflict();
475 std::sort(sorted_items.begin(), sorted_items.end(),
476 [](
const OrthogonalPackingResult::Item& a,
477 const OrthogonalPackingResult::Item& b) {
478 return a.size_x * a.size_y > b.size_x * b.size_y;
480 for (
const auto& item : sorted_items) {
481 const RectangleInRange& range = conflict.items_for_opp[item.index];
482 ranges_for_explanation.push_back(
483 RectangleInRange::BiggestWithMinIntersection(rectangle, range,
484 item.size_x, item.size_y));
486 return ranges_for_explanation;
491 const int id = watcher->
Register(
this);
492 helper_.WatchAllBoxes(
id);
502IntegerValue FindCanonicalValue(IntegerValue lb, IntegerValue ub) {
503 if (lb == ub)
return lb;
504 if (lb <= 0 && ub > 0)
return IntegerValue(0);
505 if (lb < 0 && ub <= 0) {
506 return -FindCanonicalValue(-ub, -lb);
510 IntegerValue candidate = ub;
511 for (
int o = 0; o < 62; ++o) {
513 const IntegerValue masked_ub(ub.value() & ~mask);
514 if (masked_ub >= lb) {
515 candidate = masked_ub;
523void SplitDisjointBoxes(
const SchedulingConstraintHelper& x,
524 absl::Span<const int> boxes,
525 std::vector<absl::Span<const int>>* result) {
527 DCHECK(std::is_sorted(boxes.begin(), boxes.end(), [&x](
int a,
int b) {
528 return x.ShiftedStartMin(a) < x.ShiftedStartMin(b);
530 int current_start = 0;
531 std::size_t current_length = 1;
532 IntegerValue current_max_end =
x.EndMax(boxes[0]);
534 for (
int b = 1;
b < boxes.size(); ++
b) {
535 const int box = boxes[
b];
536 if (
x.ShiftedStartMin(box) < current_max_end) {
539 current_max_end = std::max(current_max_end,
x.EndMax(box));
541 if (current_length > 1) {
542 result->emplace_back(&boxes[current_start], current_length);
546 current_max_end =
x.EndMax(box);
551 if (current_length > 1) {
552 result->emplace_back(&boxes[current_start], current_length);
560NonOverlappingRectanglesDisjunctivePropagator::
561 NonOverlappingRectanglesDisjunctivePropagator(
564 x_(helper->NumBoxes(), model),
566 time_limit_(model->GetOrCreate<
TimeLimit>()),
567 overload_checker_(&x_),
568 forward_detectable_precedences_(true, &x_),
569 backward_detectable_precedences_(false, &x_),
570 forward_not_last_(true, &x_),
571 backward_not_last_(false, &x_),
572 forward_edge_finding_(true, &x_),
573 backward_edge_finding_(false, &x_),
574 disjunctive_with_two_items_(&x_) {}
580 int fast_priority,
int slow_priority) {
581 fast_id_ = watcher_->Register(
this);
582 watcher_->SetPropagatorPriority(fast_id_, fast_priority);
583 helper_->WatchAllBoxes(fast_id_);
587 watcher_->NotifyThatPropagatorMayNotReachFixedPointInOnePass(fast_id_);
589 const int slow_id = watcher_->Register(
this);
590 watcher_->SetPropagatorPriority(slow_id, slow_priority);
591 helper_->WatchAllBoxes(slow_id);
594bool NonOverlappingRectanglesDisjunctivePropagator::
595 FindBoxesThatMustOverlapAHorizontalLineAndPropagate(
596 bool fast_propagation, absl::Span<const int> requested_boxes) {
607 indexed_boxes_.resize(helper_->
NumBoxes());
615 absl::flat_hash_set<int> requested_boxes_set;
616 if (requested_boxes.size() != helper_->
NumBoxes()) {
617 requested_boxes_set = {requested_boxes.begin(), requested_boxes.end()};
623 auto fixed_boxes = already_checked_fixed_boxes_.
view();
624 for (
int i = temp.size(); --
i >= 0;) {
625 const int box = temp[
i].task_index;
626 if (requested_boxes.size() != helper_->
NumBoxes() &&
627 !requested_boxes_set.contains(box)) {
633 if (!fixed_boxes[box]) {
635 if (
x->IsAbsent(box) || y->
IsAbsent(box))
continue;
639 if (
x->IsPresent(box) && !y->
IsPresent(box))
continue;
640 if (!
x->IsPresent(box) && !y->
IsPresent(box) &&
647 const IntegerValue start_max = -temp[
i].time;
648 const IntegerValue end_min = y->
EndMin(box);
649 if (start_max < end_min) {
650 boxes_data[num_boxes++] = {box, start_max, end_min};
654 if (fixed_boxes[box]) {
657 if (helper_->IsFixed(box)) {
659 fixed_boxes.Set(box);
662 const Rectangle r = {
x->StartMin(box),
x->EndMax(box), start_max,
664 if (num_others == 0) {
665 other_bounding_box = r;
680 if (num_others == 0)
return true;
683 for (
int i = 0;
i < num_boxes; ++
i) {
684 const IndexedInterval& interval = boxes_data[
i];
685 const int box = interval.
index;
686 const Rectangle r = {
x->StartMin(box),
x->EndMax(box), interval.start,
688 if (other_bounding_box.
IsDisjoint(r))
continue;
689 boxes_data[new_size++] = interval;
691 num_boxes = new_size;
695 const auto boxes = absl::MakeSpan(boxes_data, num_boxes);
696 if (boxes.size() < 2)
return true;
707 rectangles_.reserve(boxes.size());
708 for (
const auto [box, y_mandatory_start, y_mandatory_end] : boxes) {
711 rectangles_.push_back(
712 {y_mandatory_start, y_mandatory_end,
713 x->StartMin(box),
x->EndMin(box)});
717 const size_t n = rectangles_.size();
718 time_limit_->AdvanceDeterministicTime(
719 static_cast<double>(n) *
static_cast<double>(absl::bit_width(n)) *
722 if (opt_pair == std::nullopt) {
729 order_.assign(
x->NumTasks(), 0);
732 for (
const auto [t, _lit, _time] :
x->TaskByIncreasingShiftedStartMin()) {
739 boxes_to_propagate_.clear();
740 reduced_overlapping_boxes_.clear();
741 int work_done = boxes.size();
742 for (
int i = 0;
i < events_overlapping_boxes_.size(); ++
i) {
743 work_done += events_overlapping_boxes_[
i].size();
744 SplitDisjointBoxes(*x, events_overlapping_boxes_[
i], &disjoint_boxes_);
745 for (
const absl::Span<const int> sub_boxes : disjoint_boxes_) {
749 const auto& insertion = reduced_overlapping_boxes_.insert(sub_boxes);
750 if (insertion.second) boxes_to_propagate_.push_back(sub_boxes);
755 time_limit_->AdvanceDeterministicTime(
static_cast<double>(work_done) * 1e-8);
761 for (
const absl::Span<const int> boxes : boxes_to_propagate_) {
764 if (!fast_propagation && boxes.size() <= 2)
continue;
766 x_.ClearOtherHelper();
767 if (!x_.ResetFromSubset(*x, boxes))
return false;
770 IntegerValue lb(std::numeric_limits<int64_t>::min());
771 IntegerValue ub(std::numeric_limits<int64_t>::max());
772 for (
const int b : boxes) {
774 ub = std::min(ub, y->
EndMin(
b) - 1);
786 const IntegerValue line_to_use_for_reason = FindCanonicalValue(lb, ub);
789 x_.SetOtherHelper(y, boxes, line_to_use_for_reason);
791 if (fast_propagation) {
792 if (x_.NumTasks() == 2) {
803 DCHECK_GT(x_.NumTasks(), 2);
819 if (!helper_->SynchronizeAndSetDirection(
true,
true,
false))
return false;
823 const bool backtrack_since_last_call = !rev_is_in_dive_;
824 watcher_->SetUntilNextBacktrack(&rev_is_in_dive_);
825 if (backtrack_since_last_call ||
826 last_helper_inprocessing_count_ != helper_->InProcessingCount()) {
827 last_helper_inprocessing_count_ = helper_->InProcessingCount();
828 const int num_tasks = helper_->NumBoxes();
829 already_checked_fixed_boxes_.ClearAndResize(num_tasks);
835 const bool fast_propagation = watcher_->GetCurrentId() == fast_id_;
836 for (
const auto subset : helper_->connected_components().AsVectorOfSpan()) {
837 if (!FindBoxesThatMustOverlapAHorizontalLineAndPropagate(fast_propagation,
843 if (!helper_->SynchronizeAndSetDirection(
true,
true,
true))
return false;
845 for (
const auto subset : helper_->connected_components().AsVectorOfSpan()) {
846 if (!FindBoxesThatMustOverlapAHorizontalLineAndPropagate(fast_propagation,
856 const int id = watcher->
Register(
this);
857 helper_->WatchAllBoxes(
id);
863 if (!VLOG_IS_ON(1))
return;
864 std::vector<std::pair<std::string, int64_t>> stats;
865 stats.push_back({
"RectanglePairwisePropagator/called", num_calls_});
866 stats.push_back({
"RectanglePairwisePropagator/pairwise_conflicts",
867 num_pairwise_conflicts_});
868 stats.push_back({
"RectanglePairwisePropagator/pairwise_propagations",
869 num_pairwise_propagations_});
871 shared_stats_->AddStats(stats);
875 if (!helper_->SynchronizeAndSetDirection())
return false;
878 std::vector<PairwiseRestriction> restrictions;
880 for (
int component_index = 0;
881 component_index < helper_->connected_components().size();
883 horizontal_zero_area_boxes_.clear();
884 vertical_zero_area_boxes_.clear();
885 point_zero_area_boxes_.clear();
886 fixed_non_zero_area_boxes_.clear();
887 non_fixed_non_zero_area_boxes_.clear();
888 fixed_non_zero_area_rectangles_.clear();
889 for (
int b : helper_->connected_components()[component_index]) {
890 if (!helper_->IsPresent(
b))
continue;
891 const auto [x_size_max, y_size_max] = helper_->GetBoxSizesMax(
b);
893 if (x_size_max == 0) {
894 if (y_size_max == 0) {
895 box = &point_zero_area_boxes_.emplace_back();
897 box = &vertical_zero_area_boxes_.emplace_back();
899 }
else if (y_size_max == 0) {
900 box = &horizontal_zero_area_boxes_.emplace_back();
902 if (helper_->IsFixed(
b)) {
903 box = &fixed_non_zero_area_boxes_.emplace_back();
904 fixed_non_zero_area_rectangles_.push_back(
905 helper_->GetItemRangeForSizeMin(
b).bounding_area);
907 box = &non_fixed_non_zero_area_boxes_.emplace_back();
910 *box = helper_->GetItemWithVariableSize(
b);
918 non_fixed_non_zero_area_boxes_, fixed_non_zero_area_boxes_,
922 fixed_non_zero_area_boxes_, non_fixed_non_zero_area_boxes_,
926 for (
auto& non_zero_area_boxes :
927 {fixed_non_zero_area_boxes_, non_fixed_non_zero_area_boxes_}) {
929 non_zero_area_boxes, horizontal_zero_area_boxes_, &restrictions));
931 non_zero_area_boxes, vertical_zero_area_boxes_, &restrictions));
933 non_zero_area_boxes, point_zero_area_boxes_, &restrictions));
938 vertical_zero_area_boxes_, horizontal_zero_area_boxes_, &restrictions));
946bool RectanglePairwisePropagator::FindRestrictionsAndPropagateConflict(
947 absl::Span<const ItemWithVariableSize> items,
948 std::vector<PairwiseRestriction>* restrictions) {
949 const int max_pairs =
950 params_->max_pairs_pairwise_reasoning_in_no_overlap_2d();
951 if (items.size() * (items.size() - 1) / 2 > max_pairs) {
955 for (
const PairwiseRestriction& restriction : *restrictions) {
956 if (restriction.type ==
964bool RectanglePairwisePropagator::FindRestrictionsAndPropagateConflict(
965 absl::Span<const ItemWithVariableSize> items1,
966 absl::Span<const ItemWithVariableSize> items2,
967 std::vector<PairwiseRestriction>* restrictions) {
968 const int max_pairs =
969 params_->max_pairs_pairwise_reasoning_in_no_overlap_2d();
970 if (items1.size() * items2.size() > max_pairs) {
974 for (
const PairwiseRestriction& restriction : *restrictions) {
975 if (restriction.type ==
983bool RectanglePairwisePropagator::PropagateTwoBoxes(
985 if (restriction.type ==
987 num_pairwise_conflicts_++;
989 num_pairwise_propagations_++;
991 return helper_->PropagateRelativePosition(
992 restriction.first_index, restriction.second_index, restriction.type);
995#undef RETURN_IF_FALSE
void NotifyThatPropagatorMayNotReachFixedPointInOnePass(int id)
void SetPropagatorPriority(int id, int priority)
int Register(PropagatorInterface *propagator)
Registers a propagator and returns its unique ids.
IntegerVariable AddIntegerVariable(IntegerValue lower_bound, IntegerValue upper_bound)
SchedulingConstraintHelper * GetOrCreateHelper(const std::vector< IntervalVariable > &variables, bool register_as_disjunctive_helper=false)
NoOverlap2DConstraintHelper * GetOrCreate2DHelper(const std::vector< IntervalVariable > &x_variables, const std::vector< IntervalVariable > &y_variables)
void RegisterWith(GenericLiteralWatcher *watcher)
SchedulingConstraintHelper & y_helper() const
SchedulingConstraintHelper & x_helper() const
void Register(int fast_priority, int slow_priority)
~NonOverlappingRectanglesDisjunctivePropagator() override
Propagates using a box energy reasoning.
~NonOverlappingRectanglesEnergyPropagator() override
int RegisterWith(GenericLiteralWatcher *watcher)
Propagator that compares the boxes pairwise.
~RectanglePairwisePropagator() override
int RegisterWith(GenericLiteralWatcher *watcher)
absl::Span< const TaskTime > TaskByIncreasingNegatedStartMax()
IntegerValue StartMax(int t) const
bool IsPresent(int t) const
Literal PresenceLiteral(int index) const
bool IsAbsent(int t) const
IntegerValue EndMin(int t) const
bool IsOptional(int t) const
constexpr IntegerValue kMaxIntegerValue(std::numeric_limits< IntegerValue::ValueType >::max() - 1)
std::function< void(Model *)> WeightedSumGreaterOrEqual(absl::Span< const IntegerVariable > vars, const VectorInt &coefficients, int64_t lower_bound)
Weighted sum >= constant.
void CreateAndRegisterTryEdgePropagator(NoOverlap2DConstraintHelper *helper, Model *model, GenericLiteralWatcher *watcher, int priority)
std::vector< IntegerVariable > NegationOf(absl::Span< const IntegerVariable > vars)
Returns the vector of the negated variables.
std::optional< std::pair< int, int > > FindOneIntersectionIfPresent(absl::Span< const Rectangle > rectangles)
constexpr IntegerValue kMinIntegerValue(-kMaxIntegerValue.value())
void AppendPairwiseRestrictions(absl::Span< const ItemWithVariableSize > items, std::vector< PairwiseRestriction > *result)
void ConstructOverlappingSets(absl::Span< IndexedInterval > intervals, CompactVectorVector< int > *result, absl::Span< const int > order)
void CreateAndRegisterMandatoryOverlapPropagator(NoOverlap2DConstraintHelper *helper, Model *model, GenericLiteralWatcher *watcher, int priority)
FindRectanglesResult FindRectanglesWithEnergyConflictMC(const std::vector< RectangleInRange > &intervals, absl::BitGenRef random, double temperature, double candidate_energy_usage_factor)
std::function< IntegerVariable(Model *)> NewIntegerVariable(int64_t lb, int64_t ub)
void AddNonOverlappingRectangles(const std::vector< IntervalVariable > &x, const std::vector< IntervalVariable > &y, Model *model)
void AddCumulativeOverloadChecker(AffineExpression capacity, SchedulingConstraintHelper *helper, SchedulingDemandHelper *demands, Model *model)
In SWIG mode, we don't want anything besides these top-level includes.
int64_t CapSub(int64_t x, int64_t y)
#define RETURN_IF_FALSE(f)
void GrowToInclude(const Rectangle &other)
IntegerValue SizeY() const
IntegerValue SizeX() const
bool IsDisjoint(const Rectangle &other) const