MLIR
16.0.0git
|
A FlatAffineRelation represents a set of ordered pairs (domain -> range) where "domain" and "range" are tuples of variables. More...
#include "mlir/Dialect/Affine/Analysis/AffineStructures.h"
Public Member Functions | |
FlatAffineRelation (unsigned numReservedInequalities, unsigned numReservedEqualities, unsigned numReservedCols, unsigned numDomainDims, unsigned numRangeDims, unsigned numSymbols, unsigned numLocals, ArrayRef< Optional< Value >> valArgs={}) | |
FlatAffineRelation (unsigned numDomainDims=0, unsigned numRangeDims=0, unsigned numSymbols=0, unsigned numLocals=0) | |
FlatAffineRelation (unsigned numDomainDims, unsigned numRangeDims, FlatAffineValueConstraints &fac) | |
FlatAffineRelation (unsigned numDomainDims, unsigned numRangeDims, IntegerPolyhedron &fac) | |
FlatAffineValueConstraints | getDomainSet () const |
Returns a set corresponding to the domain/range of the affine relation. More... | |
FlatAffineValueConstraints | getRangeSet () const |
unsigned | getNumDomainDims () const |
Returns the number of variables corresponding to domain/range of relation. More... | |
unsigned | getNumRangeDims () const |
void | compose (const FlatAffineRelation &other) |
Given affine relation other: (domainOther -> rangeOther) , this operation takes the composition of other on this: (domainThis -> rangeThis) . More... | |
void | inverse () |
Swap domain and range of the relation. More... | |
void | insertDomainVar (unsigned pos, unsigned num=1) |
Insert num variables of the specified kind after the pos variable of that kind. More... | |
void | insertRangeVar (unsigned pos, unsigned num=1) |
void | appendDomainVar (unsigned num=1) |
Append num variables of the specified kind after the last variable of that kind. More... | |
void | appendRangeVar (unsigned num=1) |
void | removeVarRange (VarKind kind, unsigned varStart, unsigned varLimit) override |
Removes variables in the column range [varStart, varLimit), and copies any remaining valid data into place, updates member variables, and resizes arrays as needed. More... | |
![]() | |
FlatAffineValueConstraints (unsigned numReservedInequalities, unsigned numReservedEqualities, unsigned numReservedCols, unsigned numDims, unsigned numSymbols, unsigned numLocals, ArrayRef< Optional< Value >> valArgs={}) | |
Constructs a constraint system reserving memory for the specified number of constraints and variables. More... | |
FlatAffineValueConstraints (unsigned numDims=0, unsigned numSymbols=0, unsigned numLocals=0, ArrayRef< Optional< Value >> valArgs={}) | |
Constructs a constraint system with the specified number of dimensions and symbols. More... | |
FlatAffineValueConstraints (const IntegerPolyhedron &fac, ArrayRef< Optional< Value >> valArgs={}) | |
FlatAffineValueConstraints (const AffineValueMap &avm) | |
Create a flat affine constraint system from an AffineValueMap or a list of these. More... | |
FlatAffineValueConstraints (ArrayRef< const AffineValueMap *> avmRef) | |
FlatAffineValueConstraints (IntegerSet set) | |
Creates an affine constraint system from an IntegerSet. More... | |
FlatAffineValueConstraints (ArrayRef< const AffineValueMap *> avmRef, IntegerSet set) | |
Kind | getKind () const override |
Return the kind of this FlatAffineConstraints. More... | |
void | reset (unsigned numReservedInequalities, unsigned numReservedEqualities, unsigned numReservedCols, unsigned numDims, unsigned numSymbols, unsigned numLocals=0) |
Clears any existing data and reserves memory for the specified constraints. More... | |
void | reset (unsigned numDims=0, unsigned numSymbols=0, unsigned numLocals=0) |
void | reset (unsigned numReservedInequalities, unsigned numReservedEqualities, unsigned numReservedCols, unsigned numDims, unsigned numSymbols, unsigned numLocals, ArrayRef< Value > valArgs) |
void | reset (unsigned numDims, unsigned numSymbols, unsigned numLocals, ArrayRef< Value > valArgs) |
std::unique_ptr< FlatAffineValueConstraints > | clone () const |
Clones this object. More... | |
LogicalResult | addAffineForOpDomain (AffineForOp forOp) |
Adds constraints (lower and upper bounds) for the specified 'affine.for' operation's Value using IR information stored in its bound maps. More... | |
LogicalResult | addDomainFromSliceMaps (ArrayRef< AffineMap > lbMaps, ArrayRef< AffineMap > ubMaps, ArrayRef< Value > operands) |
Adds constraints (lower and upper bounds) for each loop in the loop nest described by the bound maps lbMaps and ubMaps of a computation slice. More... | |
void | addAffineIfOpDomain (AffineIfOp ifOp) |
Adds constraints imposed by the affine.if operation. More... | |
LogicalResult | addBound (BoundType type, unsigned pos, AffineMap boundMap, bool isClosedBound) |
Adds a bound for the variable at the specified position with constraints being drawn from the specified bound map. More... | |
LogicalResult | addBound (BoundType type, unsigned pos, AffineMap boundMap) |
Adds a bound for the variable at the specified position with constraints being drawn from the specified bound map. More... | |
LogicalResult | addBound (BoundType type, unsigned pos, AffineMap boundMap, ValueRange operands) |
Adds a bound for the variable at the specified position with constraints being drawn from the specified bound map and operands. More... | |
void | addBound (BoundType type, Value val, int64_t value) |
Adds a constant bound for the variable associated with the given Value. More... | |
IntegerSet | getAsIntegerSet (MLIRContext *context) const |
Returns the constraint system as an integer set. More... | |
void | getSliceBounds (unsigned offset, unsigned num, MLIRContext *context, SmallVectorImpl< AffineMap > *lbMaps, SmallVectorImpl< AffineMap > *ubMaps, bool getClosedUB=false) |
Computes the lower and upper bounds of the first num dimensional variables (starting at offset ) as an affine map of the remaining variables (dimensional and symbolic). More... | |
LogicalResult | composeMatchingMap (AffineMap other) |
Composes an affine map whose dimensions and symbols match one to one with the dimensions and symbols of this FlatAffineConstraints. More... | |
std::pair< AffineMap, AffineMap > | getLowerAndUpperBound (unsigned pos, unsigned offset, unsigned num, unsigned symStartPos, ArrayRef< AffineExpr > localExprs, MLIRContext *context) const |
Gets the lower and upper bound of the offset + pos th variable treating [0, offset) U [offset + num, symStartPos) as dimensions and [symStartPos, getNumDimAndSymbolVars) as symbols, and pos lies in [0, num). More... | |
void | getIneqAsAffineValueMap (unsigned pos, unsigned ineqPos, AffineValueMap &vmap, MLIRContext *context) const |
Returns the bound for the variable at pos from the inequality at ineqPos as a 1-d affine value map (affine map + operands). More... | |
LogicalResult | addSliceBounds (ArrayRef< Value > values, ArrayRef< AffineMap > lbMaps, ArrayRef< AffineMap > ubMaps, ArrayRef< Value > operands) |
Adds slice lower bounds represented by lower bounds in lbMaps and upper bounds in ubMaps to each variable in the constraint system which has a value in values . More... | |
bool | findVar (Value val, unsigned *pos) const |
Looks up the position of the variable with the specified Value. More... | |
bool | containsVar (Value mayBeVar) const |
Returns true if an variable with the specified Value exists, false otherwise. More... | |
void | swapVar (unsigned posA, unsigned posB) override |
Swap the posA^th variable with the posB^th variable. More... | |
unsigned | insertDimVar (unsigned pos, unsigned num=1) |
Insert variables of the specified kind at position pos . More... | |
unsigned | insertSymbolVar (unsigned pos, unsigned num=1) |
unsigned | insertLocalVar (unsigned pos, unsigned num=1) |
unsigned | insertDimVar (unsigned pos, ValueRange vals) |
unsigned | insertSymbolVar (unsigned pos, ValueRange vals) |
unsigned | insertVar (presburger::VarKind kind, unsigned pos, unsigned num=1) override |
Insert num variables of the specified kind at position pos . More... | |
unsigned | insertVar (presburger::VarKind kind, unsigned pos, ValueRange vals) |
unsigned | appendDimVar (ValueRange vals) |
Append variables of the specified kind after the last variable of that kind. More... | |
unsigned | appendSymbolVar (ValueRange vals) |
unsigned | appendDimVar (unsigned num=1) |
unsigned | appendSymbolVar (unsigned num=1) |
unsigned | appendLocalVar (unsigned num=1) |
void | addInductionVarOrTerminalSymbol (Value val) |
Add the specified values as a dim or symbol var depending on its nature, if it already doesn't exist in the system. More... | |
AffineMap | computeAlignedMap (AffineMap map, ValueRange operands) const |
Align map with this constraint system based on operands . More... | |
LogicalResult | composeMap (const AffineValueMap *vMap) |
Composes the affine value map with this FlatAffineValueConstrains, adding the results of the map as dimensions at the front [0, vMap->getNumResults()) and with the dimensions set to the equalities specified by the value map. More... | |
void | projectOut (Value val) |
Projects out the variable that is associate with Value. More... | |
void | convertLoopIVSymbolsToDims () |
Changes all symbol variables which are loop IVs to dim variables. More... | |
LogicalResult | unionBoundingBox (const FlatAffineValueConstraints &other) |
Updates the constraints to be the smallest bounding (enclosing) box that contains the points of this set and that of other , with the symbols being treated specially. More... | |
void | mergeAndAlignVarsWithOther (unsigned offset, FlatAffineValueConstraints *other) |
Merge and align the variables of this and other starting at offset , so that both constraint systems get the union of the contained variables that is dimension-wise and symbol-wise unique; both constraint systems are updated so that they have the union of all variables, with this 's original variables appearing first followed by any of other 's variables that didn't appear in this . More... | |
bool | areVarsAlignedWithOther (const FlatAffineValueConstraints &other) |
Returns true if this constraint system and other are in the same space, i.e., if they are associated with the same set of variables, appearing in the same order. More... | |
void | clearAndCopyFrom (const IntegerRelation &other) override |
Replaces the contents of this FlatAffineValueConstraints with other . More... | |
Value | getValue (unsigned pos) const |
Returns the Value associated with the pos^th variable. More... | |
bool | hasValue (unsigned pos) const |
Returns true if the pos^th variable has an associated Value. More... | |
bool | hasValues () const |
Returns true if at least one variable has an associated Value. More... | |
void | getValues (unsigned start, unsigned end, SmallVectorImpl< Value > *values) const |
Returns the Values associated with variables in range [start, end). More... | |
void | getAllValues (SmallVectorImpl< Value > *values) const |
ArrayRef< Optional< Value > > | getMaybeValues () const |
ArrayRef< Optional< Value > > | getMaybeValues (presburger::VarKind kind) const |
void | setValue (unsigned pos, Value val) |
Sets the Value associated with the pos^th variable. More... | |
void | setValues (unsigned start, unsigned end, ArrayRef< Value > values) |
Sets the Values associated with the variables in the range [start, end). More... | |
void | mergeSymbolVars (FlatAffineValueConstraints &other) |
Merge and align symbols of this and other such that both get union of of symbols that are unique. More... | |
![]() | |
IntegerPolyhedron (unsigned numReservedInequalities, unsigned numReservedEqualities, unsigned numReservedCols, const PresburgerSpace &space) | |
Constructs a set reserving memory for the specified number of constraints and variables. More... | |
IntegerPolyhedron (const PresburgerSpace &space) | |
Constructs a relation with the specified number of dimensions and symbols. More... | |
IntegerPolyhedron (const IntegerRelation &rel) | |
Construct a set from an IntegerRelation. More... | |
IntegerPolyhedron (IntegerRelation &&rel) | |
Construct a set from an IntegerRelation, but instead of creating a copy, use move constructor. More... | |
std::unique_ptr< IntegerPolyhedron > | clone () const |
IntegerPolyhedron | intersect (const IntegerPolyhedron &other) const |
Return the intersection of the two relations. More... | |
PresburgerSet | subtract (const PresburgerSet &other) const |
Return the set difference of this set and the given set, i.e., return this \ set . More... | |
![]() | |
IntegerRelation (unsigned numReservedInequalities, unsigned numReservedEqualities, unsigned numReservedCols, const PresburgerSpace &space) | |
Constructs a relation reserving memory for the specified number of constraints and variables. More... | |
IntegerRelation (const PresburgerSpace &space) | |
Constructs a relation with the specified number of dimensions and symbols. More... | |
virtual | ~IntegerRelation ()=default |
std::unique_ptr< IntegerRelation > | clone () const |
const PresburgerSpace & | getSpace () const |
Returns a reference to the underlying space. More... | |
void | setSpace (const PresburgerSpace &oSpace) |
Set the space to oSpace , which should have the same number of ids as the current space. More... | |
void | setSpaceExceptLocals (const PresburgerSpace &oSpace) |
Set the space to oSpace , which should not have any local ids. More... | |
PresburgerSpace | getSpaceWithoutLocals () const |
Returns a copy of the space without locals. More... | |
void | append (const IntegerRelation &other) |
Appends constraints from other into this . More... | |
IntegerRelation | intersect (IntegerRelation other) const |
Return the intersection of the two relations. More... | |
bool | isEqual (const IntegerRelation &other) const |
Return whether this and other are equal. More... | |
bool | isSubsetOf (const IntegerRelation &other) const |
Return whether this is a subset of the given IntegerRelation. More... | |
int64_t | atEq (unsigned i, unsigned j) const |
Returns the value at the specified equality row and column. More... | |
int64_t & | atEq (unsigned i, unsigned j) |
int64_t | atIneq (unsigned i, unsigned j) const |
Returns the value at the specified inequality row and column. More... | |
int64_t & | atIneq (unsigned i, unsigned j) |
unsigned | getNumConstraints () const |
unsigned | getNumDomainVars () const |
unsigned | getNumRangeVars () const |
unsigned | getNumSymbolVars () const |
unsigned | getNumLocalVars () const |
unsigned | getNumDimVars () const |
unsigned | getNumDimAndSymbolVars () const |
unsigned | getNumVars () const |
unsigned | getNumCols () const |
Returns the number of columns in the constraint system. More... | |
unsigned | getNumEqualities () const |
unsigned | getNumInequalities () const |
unsigned | getNumReservedEqualities () const |
unsigned | getNumReservedInequalities () const |
ArrayRef< int64_t > | getEquality (unsigned idx) const |
ArrayRef< int64_t > | getInequality (unsigned idx) const |
unsigned | getNumVarKind (VarKind kind) const |
Get the number of vars of the specified kind. More... | |
unsigned | getVarKindOffset (VarKind kind) const |
Return the index at which the specified kind of vars starts. More... | |
unsigned | getVarKindEnd (VarKind kind) const |
Return the index at Which the specified kind of vars ends. More... | |
unsigned | getVarKindOverlap (VarKind kind, unsigned varStart, unsigned varLimit) const |
Get the number of elements of the specified kind in the range [varStart, varLimit). More... | |
VarKind | getVarKindAt (unsigned pos) const |
Return the VarKind of the var at the specified position. More... | |
CountsSnapshot | getCounts () const |
void | truncate (const CountsSnapshot &counts) |
unsigned | appendVar (VarKind kind, unsigned num=1) |
Append num variables of the specified kind after the last variable of that kind. More... | |
void | addInequality (ArrayRef< int64_t > inEq) |
Adds an inequality (>= 0) from the coefficients specified in inEq . More... | |
void | addEquality (ArrayRef< int64_t > eq) |
Adds an equality from the coefficients specified in eq . More... | |
virtual void | eliminateRedundantLocalVar (unsigned posA, unsigned posB) |
Eliminate the posB^th local variable, replacing every instance of it with the posA^th local variable. More... | |
void | removeVar (VarKind kind, unsigned pos) |
Removes variables of the specified kind with the specified pos (or within the specified range) from the system. More... | |
void | removeVar (unsigned pos) |
Removes the specified variable from the system. More... | |
void | removeEquality (unsigned pos) |
void | removeInequality (unsigned pos) |
void | removeEqualityRange (unsigned start, unsigned end) |
Remove the (in)equalities at positions [start, end). More... | |
void | removeInequalityRange (unsigned start, unsigned end) |
MaybeOptimum< SmallVector< Fraction, 8 > > | findRationalLexMin () const |
Get the lexicographically minimum rational point satisfying the constraints. More... | |
MaybeOptimum< SmallVector< int64_t, 8 > > | findIntegerLexMin () const |
Same as above, but returns lexicographically minimal integer point. More... | |
void | clearConstraints () |
Removes all equalities and inequalities. More... | |
void | setAndEliminate (unsigned pos, ArrayRef< int64_t > values) |
Sets the values.size() variables starting at po s to the specified values and removes them. More... | |
virtual void | clearAndCopyFrom (const IntegerRelation &other) |
Replaces the contents of this IntegerRelation with other . More... | |
void | getLowerAndUpperBoundIndices (unsigned pos, SmallVectorImpl< unsigned > *lbIndices, SmallVectorImpl< unsigned > *ubIndices, SmallVectorImpl< unsigned > *eqIndices=nullptr, unsigned offset=0, unsigned num=0) const |
Gather positions of all lower and upper bounds of the variable at pos , and optionally any equalities on it. More... | |
bool | isEmpty () const |
Checks for emptiness by performing variable elimination on all variables, running the GCD test on each equality constraint, and checking for invalid constraints. More... | |
bool | isEmptyByGCDTest () const |
Runs the GCD test on all equality constraints. More... | |
bool | isIntegerEmpty () const |
Returns true if the set of constraints is found to have no solution, false if a solution exists. More... | |
Matrix | getBoundedDirections () const |
Returns a matrix where each row is a vector along which the polytope is bounded. More... | |
Optional< SmallVector< int64_t, 8 > > | findIntegerSample () const |
Find an integer sample point satisfying the constraints using a branch and bound algorithm with generalized basis reduction, with some additional processing using Simplex for unbounded sets. More... | |
Optional< uint64_t > | computeVolume () const |
Compute an overapproximation of the number of integer points in the relation. More... | |
bool | containsPoint (ArrayRef< int64_t > point) const |
Returns true if the given point satisfies the constraints, or false otherwise. More... | |
Optional< SmallVector< int64_t, 8 > > | containsPointNoLocal (ArrayRef< int64_t > point) const |
Given the values of non-local vars, return a satisfying assignment to the local if one exists, or an empty optional otherwise. More... | |
DivisionRepr | getLocalReprs (std::vector< MaybeLocalRepr > *repr=nullptr) const |
Returns a DivisonRepr representing the division representation of local variables in the constraint system. More... | |
void | addBound (BoundType type, unsigned pos, int64_t value) |
Adds a constant bound for the specified variable. More... | |
void | addBound (BoundType type, ArrayRef< int64_t > expr, int64_t value) |
Adds a constant bound for the specified expression. More... | |
void | addLocalFloorDiv (ArrayRef< int64_t > dividend, int64_t divisor) |
Adds a new local variable as the floordiv of an affine function of other variables, the coefficients of which are provided in dividend and with respect to a positive constant divisor . More... | |
void | projectOut (unsigned pos, unsigned num) |
Projects out (aka eliminates) num variables starting at position pos . More... | |
void | projectOut (unsigned pos) |
LogicalResult | constantFoldVar (unsigned pos) |
Tries to fold the specified variable to a constant using a trivial equality detection; if successful, the constant is substituted for the variable everywhere in the constraint system and then removed from the system. More... | |
void | constantFoldVarRange (unsigned pos, unsigned num) |
This method calls constantFoldVar for the specified range of variables, num variables starting at position pos . More... | |
LogicalResult | unionBoundingBox (const IntegerRelation &other) |
Updates the constraints to be the smallest bounding (enclosing) box that contains the points of this set and that of other , with the symbols being treated specially. More... | |
Optional< int64_t > | getConstantBoundOnDimSize (unsigned pos, SmallVectorImpl< int64_t > *lb=nullptr, int64_t *boundFloorDivisor=nullptr, SmallVectorImpl< int64_t > *ub=nullptr, unsigned *minLbPos=nullptr, unsigned *minUbPos=nullptr) const |
Returns the smallest known constant bound for the extent of the specified variable (pos^th), i.e., the smallest known constant that is greater than or equal to 'exclusive upper bound' - 'lower bound' of the variable. More... | |
Optional< int64_t > | getConstantBound (BoundType type, unsigned pos) const |
Returns the constant bound for the pos^th variable if there is one; None otherwise. More... | |
void | removeIndependentConstraints (unsigned pos, unsigned num) |
Removes constraints that are independent of (i.e., do not have a coefficient) variables in the range [pos, pos + num). More... | |
bool | isHyperRectangular (unsigned pos, unsigned num) const |
Returns true if the set can be trivially detected as being hyper-rectangular on the specified contiguous set of variables. More... | |
void | removeTrivialRedundancy () |
Removes duplicate constraints, trivially true constraints, and constraints that can be detected as redundant as a result of differing only in their constant term part. More... | |
void | removeRedundantInequalities () |
A more expensive check than removeTrivialRedundancy to detect redundant inequalities. More... | |
void | removeRedundantConstraints () |
Removes redundant constraints using Simplex. More... | |
void | removeDuplicateDivs () |
void | convertVarKind (VarKind srcKind, unsigned varStart, unsigned varLimit, VarKind dstKind, unsigned pos) |
Converts variables of kind srcKind in the range [varStart, varLimit) to variables of kind dstKind. More... | |
void | convertVarKind (VarKind srcKind, unsigned varStart, unsigned varLimit, VarKind dstKind) |
void | convertToLocal (VarKind kind, unsigned varStart, unsigned varLimit) |
unsigned | mergeLocalVars (IntegerRelation &other) |
Adds additional local vars to the sets such that they both have the union of the local vars in each set, without changing the set of points that lie in this and other . More... | |
bool | hasOnlyDivLocals () const |
Check whether all local ids have a division representation. More... | |
void | setDimSymbolSeparation (unsigned newSymbolCount) |
Changes the partition between dimensions and symbols. More... | |
IntegerPolyhedron | getDomainSet () const |
Return a set corresponding to all points in the domain of the relation. More... | |
IntegerPolyhedron | getRangeSet () const |
Return a set corresponding to all points in the range of the relation. More... | |
void | intersectDomain (const IntegerPolyhedron &poly) |
Intersect the given poly with the domain in-place. More... | |
void | intersectRange (const IntegerPolyhedron &poly) |
Intersect the given poly with the range in-place. More... | |
void | inverse () |
Invert the relation i.e., swap its domain and range. More... | |
void | compose (const IntegerRelation &rel) |
Let the relation this be R1, and the relation rel be R2. More... | |
void | applyDomain (const IntegerRelation &rel) |
Given a relation rel , apply the relation to the domain of this relation. More... | |
void | applyRange (const IntegerRelation &rel) |
Given a relation rel , apply the relation to the range of this relation. More... | |
PresburgerRelation | computeReprWithOnlyDivLocals () const |
Compute an equivalent representation of the same set, such that all local vars in all disjuncts have division representations. More... | |
SymbolicLexMin | findSymbolicIntegerLexMin () const |
Compute the symbolic integer lexmin of the relation. More... | |
PresburgerRelation | subtract (const PresburgerRelation &set) const |
Return the set difference of this set and the given set, i.e., return this \ set . More... | |
void | print (raw_ostream &os) const |
void | dump () const |
Protected Attributes | |
unsigned | numDomainDims |
unsigned | numRangeDims |
![]() | |
SmallVector< Optional< Value >, 8 > | values |
Values corresponding to the (column) non-local variables of this constraint system appearing in the order the variables correspond to columns. More... | |
![]() | |
PresburgerSpace | space |
Matrix | equalities |
Coefficients of affine equalities (in == 0 form). More... | |
Matrix | inequalities |
Coefficients of affine inequalities (in >= 0 form). More... | |
Additional Inherited Members | |
![]() | |
enum | Kind { Kind::FlatAffineConstraints, Kind::FlatAffineValueConstraints, Kind::IntegerRelation, Kind::IntegerPolyhedron } |
All derived classes of IntegerRelation. More... | |
enum | BoundType { EQ, LB, UB } |
The type of bound: equal, lower bound or upper bound. More... | |
![]() | |
static FlatAffineValueConstraints | getHyperrectangular (ValueRange ivs, ValueRange lbs, ValueRange ubs) |
static bool | classof (const IntegerRelation *cst) |
![]() | |
static IntegerPolyhedron | getUniverse (const PresburgerSpace &space) |
Return a system with no constraints, i.e., one which is satisfied by all points. More... | |
static bool | classof (const IntegerRelation *cst) |
![]() | |
static IntegerRelation | getUniverse (const PresburgerSpace &space) |
Return a system with no constraints, i.e., one which is satisfied by all points. More... | |
static bool | classof (const IntegerRelation *cst) |
![]() | |
using | VarKind = presburger::VarKind |
![]() | |
bool | hasConsistentState () const override |
Returns false if the fields corresponding to various variable counts, or equality/inequality buffer sizes aren't consistent; true otherwise. More... | |
LogicalResult | flattenAlignedMapAndMergeLocals (AffineMap map, std::vector< SmallVector< int64_t, 8 >> *flattenedExprs) |
Given an affine map that is aligned with this constraint system: More... | |
void | fourierMotzkinEliminate (unsigned pos, bool darkShadow=false, bool *isResultIntegerExact=nullptr) override |
Eliminates the variable at the specified position using Fourier-Motzkin variable elimination, but uses Gaussian elimination if there is an equality involving that variable. More... | |
void | printSpace (raw_ostream &os) const override |
Prints the number of constraints, dimensions, symbols and locals in the FlatAffineConstraints. More... | |
![]() | |
bool | hasInvalidConstraint () const |
Checks all rows of equality/inequality constraints for trivial contradictions (for example: 1 == 0, 0 >= 1), which may have surfaced after elimination. More... | |
template<bool isLower> | |
Optional< int64_t > | computeConstantLowerOrUpperBound (unsigned pos) |
Returns the constant lower bound bound if isLower is true, and the upper bound if isLower is false. More... | |
LogicalResult | gaussianEliminateVar (unsigned position) |
Eliminates a single variable at position from equality and inequality constraints. More... | |
void | removeRedundantLocalVars () |
Removes local variables using equalities. More... | |
unsigned | gaussianEliminateVars (unsigned posStart, unsigned posLimit) |
Eliminates variables from equality and inequality constraints in column range [posStart, posLimit). More... | |
void | gcdTightenInequalities () |
Tightens inequalities given that we are dealing with integer spaces. More... | |
void | normalizeConstraintsByGCD () |
Normalized each constraints by the GCD of its coefficients. More... | |
bool | findConstraintWithNonZeroAt (unsigned colIdx, bool isEq, unsigned *rowIdx) const |
Searches for a constraint with a non-zero coefficient at colIdx in equality (isEq=true) or inequality (isEq=false) constraints. More... | |
bool | isColZero (unsigned pos) const |
Returns true if the pos^th column is all zero for both inequalities and equalities. More... | |
void | removeVarRange (unsigned varStart, unsigned varLimit) |
Removes variables in the column range [varStart, varLimit), and copies any remaining valid data into place, updates member variables, and resizes arrays as needed. More... | |
void | truncateVarKind (VarKind kind, unsigned num) |
Truncate the vars of the specified kind to the specified number by dropping some vars at the end. More... | |
void | truncateVarKind (VarKind kind, const CountsSnapshot &counts) |
Truncate the vars to the number in the space of the specified CountsSnapshot. More... | |
![]() | |
static constexpr unsigned | kExplosionFactor = 32 |
A parameter that controls detection of an unrealistic number of constraints. More... | |
A FlatAffineRelation represents a set of ordered pairs (domain -> range) where "domain" and "range" are tuples of variables.
The relation is represented as a FlatAffineValueConstraints with separation of dimension variables into domain and range. The variables are stored as: [domainVars, rangeVars, symbolVars, localVars, constant].
Definition at line 513 of file AffineStructures.h.
|
inline |
Definition at line 515 of file AffineStructures.h.
References mlir::FlatAffineValueConstraints::FlatAffineValueConstraints().
|
inline |
Definition at line 525 of file AffineStructures.h.
|
inline |
Definition at line 531 of file AffineStructures.h.
|
inline |
Definition at line 536 of file AffineStructures.h.
References mlir::presburger::IntegerRelation::getDomainSet(), and mlir::presburger::IntegerRelation::getRangeSet().
Append num
variables of the specified kind after the last variable of that kind.
The coefficient columns corresponding to the added variables are initialized to zero.
Definition at line 1717 of file AffineStructures.cpp.
References mlir::FlatAffineValueConstraints::insertDimVar().
Definition at line 1722 of file AffineStructures.cpp.
References mlir::presburger::IntegerRelation::getNumDimVars(), and mlir::FlatAffineValueConstraints::insertDimVar().
Referenced by compose().
void FlatAffineRelation::compose | ( | const FlatAffineRelation & | other | ) |
Given affine relation other: (domainOther -> rangeOther)
, this operation takes the composition of other
on this: (domainThis -> rangeThis)
.
The resulting relation represents tuples of the form: domainOther -> rangeThis
.
Definition at line 1631 of file AffineStructures.cpp.
References mlir::presburger::IntegerRelation::append(), appendRangeVar(), mlir::presburger::IntegerRelation::convertToLocal(), mlir::FlatAffineValueConstraints::getMaybeValues(), getNumDomainDims(), getNumRangeDims(), mlir::presburger::IntegerRelation::mergeLocalVars(), mlir::FlatAffineValueConstraints::mergeSymbolVars(), mlir::presburger::IntegerRelation::removeRedundantLocalVars(), mlir::FlatAffineValueConstraints::setValue(), value, and mlir::FlatAffineValueConstraints::values.
Referenced by mlir::checkMemrefAccessDependence().
FlatAffineValueConstraints FlatAffineRelation::getDomainSet | ( | ) | const |
Returns a set corresponding to the domain/range of the affine relation.
Definition at line 1616 of file AffineStructures.cpp.
References mlir::presburger::IntegerRelation::convertToLocal().
Referenced by mlir::checkMemrefAccessDependence().
|
inline |
Returns the number of variables corresponding to domain/range of relation.
Definition at line 547 of file AffineStructures.h.
Referenced by compose(), mlir::MemRefAccess::getAccessRelation(), and mlir::getRelationFromMap().
|
inline |
Definition at line 548 of file AffineStructures.h.
References mlir::presburger::IntegerRelation::compose(), mlir::presburger::IntegerRelation::inverse(), and mlir::FlatAffineValueConstraints::removeVarRange().
Referenced by compose(), mlir::MemRefAccess::getAccessRelation(), and mlir::getRelationFromMap().
FlatAffineValueConstraints FlatAffineRelation::getRangeSet | ( | ) | const |
Definition at line 1624 of file AffineStructures.cpp.
References mlir::presburger::IntegerRelation::convertToLocal().
Insert num
variables of the specified kind after the pos
variable of that kind.
The coefficient columns corresponding to the added variables are initialized to zero.
Definition at line 1703 of file AffineStructures.cpp.
References mlir::FlatAffineValueConstraints::insertDimVar().
Referenced by mlir::MemRefAccess::getAccessRelation().
Definition at line 1710 of file AffineStructures.cpp.
References mlir::FlatAffineValueConstraints::insertDimVar().
void FlatAffineRelation::inverse | ( | ) |
Swap domain and range of the relation.
(domain -> range)
is converted to (range -> domain)
.
Definition at line 1688 of file AffineStructures.cpp.
References mlir::FlatAffineValueConstraints::removeVarRange(), and mlir::FlatAffineValueConstraints::swapVar().
Referenced by mlir::checkMemrefAccessDependence().
|
overridevirtual |
Removes variables in the column range [varStart, varLimit), and copies any remaining valid data into place, updates member variables, and resizes arrays as needed.
Reimplemented from mlir::FlatAffineValueConstraints.
Definition at line 1727 of file AffineStructures.cpp.
|
protected |
Definition at line 581 of file AffineStructures.h.
|
protected |
Definition at line 584 of file AffineStructures.h.