MLIR  19.0.0git
Public Member Functions | Static Public Member Functions | List of all members
mlir::affine::FlatAffineValueConstraints Class Reference

FlatAffineValueConstraints is an extension of FlatLinearValueConstraints with helper functions for Affine dialect ops. More...

#include "mlir/Dialect/Affine/Analysis/AffineStructures.h"

+ Inheritance diagram for mlir::affine::FlatAffineValueConstraints:

Public Member Functions

Kind getKind () const override
 Return the kind of 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 addAffineParallelOpDomain (AffineParallelOp parallelOp)
 Add constraints (lower and upper bounds) for the specified 'affine.parallel' 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 (presburger::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 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...
 
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...
 
void convertLoopIVSymbolsToDims ()
 Changes all symbol variables which are loop IVs to dim variables. 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 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...
 
 FlatLinearValueConstraints (unsigned numReservedInequalities, unsigned numReservedEqualities, unsigned numReservedCols, unsigned numDims, unsigned numSymbols, unsigned numLocals, ArrayRef< std::optional< Value >> valArgs)
 Constructs a constraint system reserving memory for the specified number of constraints and variables. More...
 
 FlatLinearValueConstraints (unsigned numReservedInequalities, unsigned numReservedEqualities, unsigned numReservedCols, unsigned numDims, unsigned numSymbols, unsigned numLocals, ArrayRef< Value > valArgs)
 Constructs a constraint system reserving memory for the specified number of constraints and variables. More...
 
 FlatLinearValueConstraints (unsigned numDims, unsigned numSymbols, unsigned numLocals, ArrayRef< std::optional< Value >> valArgs)
 Constructs a constraint system with the specified number of dimensions and symbols. More...
 
 FlatLinearValueConstraints (unsigned numDims=0, unsigned numSymbols=0, unsigned numLocals=0, ArrayRef< Value > valArgs={})
 Constructs a constraint system with the specified number of dimensions and symbols. More...
 
 FlatLinearValueConstraints (const IntegerPolyhedron &fac, ArrayRef< std::optional< Value >> valArgs={})
 
 FlatLinearValueConstraints (IntegerSet set, ValueRange operands={})
 Creates an affine constraint system from an IntegerSet. More...
 
void addBound (presburger::BoundType type, Value val, int64_t value)
 Adds a constant bound for the variable associated with the given Value. More...
 
LogicalResult addBound (presburger::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 (presburger::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...
 
- Public Member Functions inherited from mlir::FlatLinearValueConstraints
 FlatLinearValueConstraints (unsigned numReservedInequalities, unsigned numReservedEqualities, unsigned numReservedCols, unsigned numDims, unsigned numSymbols, unsigned numLocals, ArrayRef< std::optional< Value >> valArgs)
 Constructs a constraint system reserving memory for the specified number of constraints and variables. More...
 
 FlatLinearValueConstraints (unsigned numReservedInequalities, unsigned numReservedEqualities, unsigned numReservedCols, unsigned numDims, unsigned numSymbols, unsigned numLocals, ArrayRef< Value > valArgs)
 Constructs a constraint system reserving memory for the specified number of constraints and variables. More...
 
 FlatLinearValueConstraints (unsigned numDims, unsigned numSymbols, unsigned numLocals, ArrayRef< std::optional< Value >> valArgs)
 Constructs a constraint system with the specified number of dimensions and symbols. More...
 
 FlatLinearValueConstraints (unsigned numDims=0, unsigned numSymbols=0, unsigned numLocals=0, ArrayRef< Value > valArgs={})
 Constructs a constraint system with the specified number of dimensions and symbols. More...
 
 FlatLinearValueConstraints (const IntegerPolyhedron &fac, ArrayRef< std::optional< Value >> valArgs={})
 
 FlatLinearValueConstraints (IntegerSet set, ValueRange operands={})
 Creates an affine constraint system from an IntegerSet. More...
 
void addBound (presburger::BoundType type, Value val, int64_t value)
 Adds a constant bound for the variable associated with the given Value. More...
 
Value getValue (unsigned pos) const
 Returns the Value associated with the pos^th variable. More...
 
void getValues (unsigned start, unsigned end, SmallVectorImpl< Value > *values) const
 Returns the Values associated with variables in range [start, end). More...
 
SmallVector< std::optional< Value > > getMaybeValues () const
 
SmallVector< std::optional< Value > > getMaybeValues (presburger::VarKind kind) const
 
bool hasValue (unsigned pos) const
 Returns true if the pos^th variable has an associated Value. More...
 
unsigned appendDimVar (ValueRange vals)
 
unsigned appendSymbolVar (ValueRange vals)
 
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)
 
void removeVarRange (presburger::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...
 
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...
 
bool findVar (Value val, unsigned *pos, unsigned offset=0) const
 Looks up the position of the variable with the specified Value starting with variables at offset offset. More...
 
bool containsVar (Value val) const
 Returns true if a variable with the specified Value exists, false otherwise. More...
 
void projectOut (Value val)
 Projects out the variable that is associate with Value. More...
 
void printSpace (raw_ostream &os) const override
 Prints the number of constraints, dimensions, symbols and locals in the FlatAffineValueConstraints. More...
 
AffineMap computeAlignedMap (AffineMap map, ValueRange operands) const
 Align map with this constraint system based on operands. More...
 
void mergeAndAlignVarsWithOther (unsigned offset, FlatLinearValueConstraints *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...
 
void mergeSymbolVars (FlatLinearValueConstraints &other)
 Merge and align symbols of this and other such that both get union of of symbols that are unique. More...
 
bool areVarsAlignedWithOther (const FlatLinearConstraints &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...
 
LogicalResult unionBoundingBox (const FlatLinearValueConstraints &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...
 
LogicalResult addBound (presburger::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 (presburger::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...
 
unsigned appendDimVar (unsigned num=1)
 Append variables of the specified kind after the last variable of that kind. More...
 
unsigned appendSymbolVar (unsigned num=1)
 
unsigned insertDimVar (unsigned pos, unsigned num=1)
 Insert variables of the specified kind at position pos. More...
 
unsigned insertSymbolVar (unsigned pos, unsigned num=1)
 
- Public Member Functions inherited from mlir::FlatLinearConstraints
 FlatLinearConstraints (unsigned numReservedInequalities, unsigned numReservedEqualities, unsigned numReservedCols, unsigned numDims, unsigned numSymbols, unsigned numLocals)
 Constructs a constraint system reserving memory for the specified number of constraints and variables. More...
 
 FlatLinearConstraints (unsigned numDims=0, unsigned numSymbols=0, unsigned numLocals=0)
 Constructs a constraint system with the specified number of dimensions and symbols. More...
 
 FlatLinearConstraints (const IntegerPolyhedron &fac)
 
LogicalResult addBound (presburger::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 (presburger::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...
 
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 closedUB=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 FlatLinearConstraints. More...
 
std::pair< AffineMap, AffineMapgetLowerAndUpperBound (unsigned pos, unsigned offset, unsigned num, unsigned symStartPos, ArrayRef< AffineExpr > localExprs, MLIRContext *context, bool closedUB=false) const
 Gets the lower and upper bound of the offset + posth variable treating [0, offset) U [offset + num, symStartPos) as dimensions and [symStartPos, getNumDimAndSymbolVars) as symbols, and pos lies in [0, num). 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 appendDimVar (unsigned num=1)
 Append variables of the specified kind after the last variable of that kind. More...
 
unsigned appendSymbolVar (unsigned num=1)
 
unsigned appendLocalVar (unsigned num=1)
 
- Public Member Functions inherited from mlir::presburger::IntegerPolyhedron
 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 PresburgerSpace &space, IntMatrix inequalities)
 Constructs a relation with the specified number of dimensions and symbols and adds the given inequalities. More...
 
 IntegerPolyhedron (const PresburgerSpace &space, FracMatrix inequalities)
 Constructs a relation with the specified number of dimensions and symbols and adds the given inequalities, after normalizing row-wise to integer values. 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< IntegerPolyhedronclone () const
 
unsigned insertVar (VarKind kind, unsigned pos, unsigned num=1) override
 Insert num variables of the specified kind at position pos. More...
 
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...
 
- Public Member Functions inherited from mlir::presburger::IntegerRelation
 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< IntegerRelationclone () const
 
const PresburgerSpacegetSpace () 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...
 
void setId (VarKind kind, unsigned i, Identifier id)
 Set the identifier for the ith variable of the specified kind of the IntegerRelation's PresburgerSpace. More...
 
void resetIds ()
 
ArrayRef< IdentifiergetIds (VarKind kind)
 Get the identifiers for the variables of specified varKind. 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 isObviouslyEqual (const IntegerRelation &other) const
 Perform a quick equality check on this and other. More...
 
bool isSubsetOf (const IntegerRelation &other) const
 Return whether this is a subset of the given IntegerRelation. More...
 
MPInt atEq (unsigned i, unsigned j) const
 Returns the value at the specified equality row and column. More...
 
int64_t atEq64 (unsigned i, unsigned j) const
 The same, but casts to int64_t. More...
 
MPIntatEq (unsigned i, unsigned j)
 
MPInt atIneq (unsigned i, unsigned j) const
 Returns the value at the specified inequality row and column. More...
 
int64_t atIneq64 (unsigned i, unsigned j) const
 The same, but casts to int64_t. More...
 
MPIntatIneq (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< MPIntgetEquality (unsigned idx) const
 
ArrayRef< MPIntgetInequality (unsigned idx) const
 
SmallVector< int64_t, 8 > getEquality64 (unsigned idx) const
 The same, but casts to int64_t. More...
 
SmallVector< int64_t, 8 > getInequality64 (unsigned idx) const
 
IntMatrix getInequalities () 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< MPInt > inEq)
 Adds an inequality (>= 0) from the coefficients specified in inEq. More...
 
void addInequality (ArrayRef< int64_t > inEq)
 
void addEquality (ArrayRef< MPInt > eq)
 Adds an equality from the coefficients specified in eq. More...
 
void addEquality (ArrayRef< int64_t > eq)
 
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< MPInt, 8 > > findIntegerLexMin () const
 Same as above, but returns lexicographically minimal integer point. More...
 
virtual void swapVar (unsigned posA, unsigned posB)
 Swap the posA^th variable with the posB^th variable. More...
 
void clearConstraints ()
 Removes all equalities and inequalities. More...
 
void setAndEliminate (unsigned pos, ArrayRef< MPInt > values)
 Sets the values.size() variables starting at pos to the specified values and removes them. More...
 
void setAndEliminate (unsigned pos, ArrayRef< int64_t > values)
 
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 isObviouslyEmpty () const
 Performs GCD checks and invalid constraint checks. 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...
 
IntMatrix getBoundedDirections () const
 Returns a matrix where each row is a vector along which the polytope is bounded. More...
 
std::optional< SmallVector< MPInt, 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...
 
std::optional< MPIntcomputeVolume () const
 Compute an overapproximation of the number of integer points in the relation. More...
 
bool containsPoint (ArrayRef< MPInt > point) const
 Returns true if the given point satisfies the constraints, or false otherwise. More...
 
bool containsPoint (ArrayRef< int64_t > point) const
 
std::optional< SmallVector< MPInt, 8 > > containsPointNoLocal (ArrayRef< MPInt > 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...
 
std::optional< SmallVector< MPInt, 8 > > containsPointNoLocal (ArrayRef< int64_t > point) const
 
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, const MPInt &value)
 Adds a constant bound for the specified variable. More...
 
void addBound (BoundType type, unsigned pos, int64_t value)
 
void addBound (BoundType type, ArrayRef< MPInt > expr, const MPInt &value)
 Adds a constant bound for the specified expression. More...
 
void addBound (BoundType type, ArrayRef< int64_t > expr, int64_t value)
 
void addLocalFloorDiv (ArrayRef< MPInt > dividend, const MPInt &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 addLocalFloorDiv (ArrayRef< int64_t > dividend, int64_t divisor)
 
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...
 
std::optional< MPIntgetConstantBoundOnDimSize (unsigned pos, SmallVectorImpl< MPInt > *lb=nullptr, MPInt *boundFloorDivisor=nullptr, SmallVectorImpl< MPInt > *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...
 
std::optional< int64_t > getConstantBoundOnDimSize64 (unsigned pos, SmallVectorImpl< int64_t > *lb=nullptr, int64_t *boundFloorDivisor=nullptr, SmallVectorImpl< int64_t > *ub=nullptr, unsigned *minLbPos=nullptr, unsigned *minUbPos=nullptr) const
 The same, but casts to int64_t. More...
 
std::optional< MPIntgetConstantBound (BoundType type, unsigned pos) const
 Returns the constant bound for the pos^th variable if there is one; std::nullopt otherwise. More...
 
std::optional< int64_t > getConstantBound64 (BoundType type, unsigned pos) const
 The same, but casts to int64_t. 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 simplify ()
 Simplify the constraint system by removing canonicalizing constraints and removing redundant constraints. More...
 
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)
 
void mergeAndAlignSymbols (IntegerRelation &other)
 Merge and align symbol variables of this and other with respect to identifiers. More...
 
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...
 
void mergeAndCompose (const IntegerRelation &other)
 Given a relation other: (A -> B), this operation merges the symbol and local variables and then takes the composition of other on this: (B -> C). More...
 
PresburgerRelation computeReprWithOnlyDivLocals () const
 Compute an equivalent representation of the same set, such that all local vars in all disjuncts have division representations. More...
 
SymbolicLexOpt findSymbolicIntegerLexMin () const
 Compute the symbolic integer lexmin of the relation. More...
 
SymbolicLexOpt findSymbolicIntegerLexMax () const
 Same as findSymbolicIntegerLexMin but produces lexmax instead of lexmin. 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 removeTrivialEqualities ()
 
bool isFullDim ()
 
void print (raw_ostream &os) const
 
void dump () const
 

Static Public Member Functions

static bool classof (const IntegerRelation *cst)
 
- Static Public Member Functions inherited from mlir::FlatLinearValueConstraints
static bool classof (const IntegerRelation *cst)
 
- Static Public Member Functions inherited from mlir::presburger::IntegerPolyhedron
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 Public Member Functions inherited from mlir::presburger::IntegerRelation
static IntegerRelation getUniverse (const PresburgerSpace &space)
 Return a system with no constraints, i.e., one which is satisfied by all points. More...
 
static IntegerRelation getEmpty (const PresburgerSpace &space)
 Return an empty system containing an invalid equation 0 = 1. More...
 
static bool classof (const IntegerRelation *cst)
 

Additional Inherited Members

- Public Types inherited from mlir::FlatLinearValueConstraints
using Identifier = presburger::Identifier
 The SSA Values attached to each non-local variable are stored as identifiers in the constraint system's space. More...
 
- Public Types inherited from mlir::presburger::IntegerRelation
enum class  Kind {
  IntegerRelation , IntegerPolyhedron , FlatLinearConstraints , FlatLinearValueConstraints ,
  FlatAffineValueConstraints , FlatAffineRelation
}
 All derived classes of IntegerRelation. More...
 
- Protected Types inherited from mlir::FlatLinearConstraints
using VarKind = presburger::VarKind
 
- Protected Member Functions inherited from mlir::FlatLinearConstraints
LogicalResult computeLocalVars (SmallVectorImpl< AffineExpr > &memo, MLIRContext *context) const
 Compute an explicit representation for local vars. More...
 
LogicalResult flattenAlignedMapAndMergeLocals (AffineMap map, std::vector< SmallVector< int64_t, 8 >> *flattenedExprs)
 Given an affine map that is aligned with this constraint system: More...
 
- Protected Member Functions inherited from mlir::presburger::IntegerRelation
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>
std::optional< MPIntcomputeConstantLowerOrUpperBound (unsigned pos)
 Returns the constant lower bound if isLower is true, and the upper bound if isLower is false. More...
 
template<bool isLower>
std::optional< int64_t > computeConstantLowerOrUpperBound64 (unsigned pos)
 The same, but casts to int64_t. 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...
 
bool gaussianEliminate ()
 Perform a Gaussian elimination operation to reduce all equations to standard form. More...
 
virtual void fourierMotzkinEliminate (unsigned pos, bool darkShadow=false, bool *isResultIntegerExact=nullptr)
 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 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...
 
bool removeDuplicateConstraints ()
 Checks for identical inequalities and eliminates redundant inequalities. More...
 
virtual bool hasConsistentState () const
 Returns false if the fields corresponding to various variable counts, or equality/inequality buffer sizes aren't consistent; true otherwise. 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...
 
- Protected Attributes inherited from mlir::presburger::IntegerRelation
PresburgerSpace space
 
IntMatrix equalities
 Coefficients of affine equalities (in == 0 form). More...
 
IntMatrix inequalities
 Coefficients of affine inequalities (in >= 0 form). More...
 
- Static Protected Attributes inherited from mlir::presburger::IntegerRelation
constexpr static unsigned kExplosionFactor = 32
 A parameter that controls detection of an unrealistic number of constraints. More...
 

Detailed Description

FlatAffineValueConstraints is an extension of FlatLinearValueConstraints with helper functions for Affine dialect ops.

Definition at line 45 of file AffineStructures.h.

Member Function Documentation

◆ addAffineForOpDomain()

LogicalResult FlatAffineValueConstraints::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.

The right variable is first looked up using forOp's Value. Asserts if the Value corresponding to the 'affine.for' operation isn't found in the constraint system. Returns failure for the yet unimplemented/unsupported cases. Any new variables that are found in the bound operands of the 'affine.for' operation are added as trailing variables (either dimensional or symbolic depending on whether the operand is a valid symbol).

Definition at line 70 of file AffineStructures.cpp.

References mlir::failed(), mlir::failure(), and mlir::success().

Referenced by addMissingLoopIVBounds(), mlir::affine::ComputationSliceState::getAsConstraints(), mlir::affine::ComputationSliceState::getSourceAsConstraints(), and mlir::affine::ComputationSliceState::isMaximal().

◆ addAffineIfOpDomain()

void FlatAffineValueConstraints::addAffineIfOpDomain ( AffineIfOp  ifOp)

Adds constraints imposed by the affine.if operation.

These constraints are collected from the IntegerSet attached to the given affine.if instance argument (ifOp). It is asserted that: 1) The IntegerSet of the given affine.if instance should not contain semi-affine expressions, 2) The columns of the constraint system created from ifOp should match the columns in the current one regarding numbers and values.

Definition at line 199 of file AffineStructures.cpp.

References mlir::affine::canonicalizeSetAndOperands().

◆ addAffineParallelOpDomain()

LogicalResult FlatAffineValueConstraints::addAffineParallelOpDomain ( AffineParallelOp  parallelOp)

Add constraints (lower and upper bounds) for the specified 'affine.parallel' operation's Value using IR information stored in its bound maps.

Returns failure for the yet unimplemented/unsupported cases. Asserts if the Value corresponding to the 'affine.parallel' operation isn't found in the constraint system.

Definition at line 121 of file AffineStructures.cpp.

References mlir::failed(), mlir::failure(), mlir::AffineMap::getSingleConstantResult(), mlir::AffineMap::isConstant(), and mlir::success().

◆ addBound() [1/4]

LogicalResult FlatLinearConstraints::addBound

Adds a bound for the variable at the specified position with constraints being drawn from the specified bound map.

In case of an EQ bound, the bound map is expected to have exactly one result. In case of a LB/UB, the bound map may have more than one result, for each of which an inequality is added. Note: The dimensions/symbols of this FlatLinearConstraints must match the dimensions/symbols of the affine map. By default the lower bound is closed and the upper bound is open.

Definition at line 296 of file FlatLinearValueConstraints.cpp.

◆ addBound() [2/4]

LogicalResult FlatLinearConstraints::addBound

Adds a bound for the variable at the specified position with constraints being drawn from the specified bound map.

In case of an EQ bound, the bound map is expected to have exactly one result. In case of a LB/UB, the bound map may have more than one result, for each of which an inequality is added.

The bound can be added as open or closed by specifying isClosedBound. In case of a LB/UB, isClosedBound = false means the bound is added internally as a closed bound by +1/-1 respectively. In case of an EQ bound, it can only be added as a closed bound.

Note: The dimensions/symbols of this FlatLinearConstraints must match the dimensions/symbols of the affine map.

Definition at line 296 of file FlatLinearValueConstraints.cpp.

◆ addBound() [3/4]

LogicalResult FlatAffineValueConstraints::addBound ( presburger::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.

In case of an EQ bound, the bound map is expected to have exactly one result. In case of a LB/UB, the bound map may have more than one result, for each of which an inequality is added.

Definition at line 216 of file AffineStructures.cpp.

References mlir::affine::canonicalizeMapAndOperands(), mlir::affine::fullyComposeAffineMapAndOperands(), and mlir::simplifyAffineMap().

Referenced by mlir::scf::addLoopRangeConstraints(), alignAndAddBound(), mlir::affine::ComputationSliceState::getAsConstraints(), mlir::affine::MemRefRegion::getConstantBoundingSizeAndShape(), and mlir::affine::normalizeMemRefType().

◆ addBound() [4/4]

void FlatLinearValueConstraints::addBound

Adds a constant bound for the variable associated with the given Value.

Definition at line 295 of file FlatLinearValueConstraints.cpp.

◆ addDomainFromSliceMaps()

LogicalResult FlatAffineValueConstraints::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.

Every pair (lbMaps[i], ubMaps[i]) describes the bounds of a loop in the nest, sorted outer-to-inner. operands contains the bound operands for a single bound map. All the bound maps will use the same bound operands. Note that some loops described by a computation slice might not exist yet in the IR so the Value attached to those dimension variables might be empty. For that reason, this method doesn't perform Value look-ups to retrieve the dimension variable positions. Instead, it assumes the position of the dim variables in the constraint system is the same as the position of the loop in the loop nest.

Definition at line 150 of file AffineStructures.cpp.

References mlir::failed(), mlir::failure(), mlir::affine::getForInductionVarOwner(), mlir::AffineMap::getNumInputs(), mlir::AffineMap::getNumResults(), mlir::AffineDimExpr::getPosition(), mlir::AffineMap::getResult(), and mlir::success().

Referenced by mlir::affine::ComputationSliceState::isMaximal().

◆ addInductionVarOrTerminalSymbol()

void FlatAffineValueConstraints::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.

val has to be either a terminal symbol or a loop IV, i.e., it cannot be the result affine.apply of any symbols or loop IVs. The variable is added to the end of the existing dims or symbols. Additional information on the variable is extracted from the IR and added to the constraint system.

Definition at line 39 of file AffineStructures.cpp.

References mlir::failed(), mlir::affine::getAffineParallelInductionVarOwner(), mlir::getConstantIntValue(), mlir::affine::getForInductionVarOwner(), mlir::affine::isAffineInductionVar(), and mlir::affine::isTopLevelValue().

◆ addSliceBounds()

LogicalResult FlatAffineValueConstraints::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.

Note that both lower/upper bounds share the same operand list operands. This function assumes values.size == lbMaps.size == ubMaps.size. Note that both lower/upper bounds use operands from operands.

Definition at line 240 of file AffineStructures.cpp.

References mlir::failed(), mlir::failure(), mlir::affine::getForInductionVarOwner(), mlir::AffineMap::getNumInputs(), mlir::AffineMap::getNumResults(), mlir::AffineMap::getResult(), and mlir::success().

Referenced by mlir::affine::ComputationSliceState::getAsConstraints().

◆ classof()

static bool mlir::affine::FlatAffineValueConstraints::classof ( const IntegerRelation cst)
inlinestatic

◆ composeMap()

LogicalResult FlatAffineValueConstraints::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.

Returns failure if the composition fails (when vMap is a semi-affine map). The vMap's operand Value's are used to look up the right positions in the FlatAffineValueConstraints with which to associate. Every operand of vMap should have a matching dim/symbol column in this constraint system (with the same associated Value).

Definition at line 284 of file AffineStructures.cpp.

References mlir::affine::AffineValueMap::getAffineMap(), and mlir::affine::AffineValueMap::getOperands().

◆ convertLoopIVSymbolsToDims()

void FlatAffineValueConstraints::convertLoopIVSymbolsToDims ( )

Changes all symbol variables which are loop IVs to dim variables.

Definition at line 300 of file AffineStructures.cpp.

References mlir::affine::getForInductionVarOwner(), and turnSymbolIntoDim().

Referenced by mlir::affine::computeSliceUnion().

◆ FlatLinearValueConstraints() [1/6]

mlir::FlatLinearValueConstraints::FlatLinearValueConstraints
inline

Definition at line 272 of file FlatLinearValueConstraints.h.

◆ FlatLinearValueConstraints() [2/6]

FlatLinearValueConstraints::FlatLinearValueConstraints
explicit

Creates an affine constraint system from an IntegerSet.

Definition at line 284 of file FlatLinearValueConstraints.cpp.

◆ FlatLinearValueConstraints() [3/6]

mlir::FlatLinearValueConstraints::FlatLinearValueConstraints
inline

Constructs a constraint system with the specified number of dimensions and symbols.

valArgs are the optional SSA values associated with each dimension/symbol. These must either be empty or match the number of dimensions and symbols.

Definition at line 250 of file FlatLinearValueConstraints.h.

◆ FlatLinearValueConstraints() [4/6]

mlir::FlatLinearValueConstraints::FlatLinearValueConstraints
inline

Constructs a constraint system with the specified number of dimensions and symbols.

valArgs are the optional SSA values associated with each dimension/symbol. These must either be empty or match the number of dimensions and symbols.

Definition at line 263 of file FlatLinearValueConstraints.h.

◆ FlatLinearValueConstraints() [5/6]

mlir::FlatLinearValueConstraints::FlatLinearValueConstraints
inline

Constructs a constraint system reserving memory for the specified number of constraints and variables.

valArgs are the optional SSA values associated with each dimension/symbol. These must either be empty or match the number of dimensions and symbols.

Definition at line 216 of file FlatLinearValueConstraints.h.

◆ FlatLinearValueConstraints() [6/6]

mlir::FlatLinearValueConstraints::FlatLinearValueConstraints
inline

Constructs a constraint system reserving memory for the specified number of constraints and variables.

valArgs are the optional SSA values associated with each dimension/symbol. These must either be empty or match the number of dimensions and symbols.

Definition at line 233 of file FlatLinearValueConstraints.h.

◆ getIneqAsAffineValueMap()

void FlatAffineValueConstraints::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).

The returned affine value map can either be a lower bound or an upper bound depending on the sign of atIneq(ineqPos, pos). Asserts if the row at ineqPos does not involve the posth variable.

Definition at line 313 of file AffineStructures.cpp.

References mlir::failed(), mlir::AffineMap::get(), mlir::getAffineExprFromFlatForm(), and mlir::affine::AffineValueMap::reset().

Referenced by createFullTiles().

◆ getKind()

Kind mlir::affine::FlatAffineValueConstraints::getKind ( ) const
inlineoverridevirtual

Return the kind of this object.

Reimplemented from mlir::FlatLinearValueConstraints.

Reimplemented in mlir::affine::FlatAffineRelation.

Definition at line 50 of file AffineStructures.h.

References mlir::presburger::IntegerRelation::FlatAffineValueConstraints.


The documentation for this class was generated from the following files: