linbox
Data Structures
Here are the data structures with brief descriptions:
allocatorSTL class
auto_ptrSTL class
bad_allocSTL class
bad_castSTL class
bad_exceptionSTL class
bad_typeidSTL class
basic_fstreamSTL class
basic_ifstreamSTL class
basic_iosSTL class
basic_iostreamSTL class
basic_istreamSTL class
basic_istringstreamSTL class
basic_ofstreamSTL class
basic_ostreamSTL class
basic_ostringstreamSTL class
basic_stringSTL class
basic_stringstreamSTL class
bitsetSTL class
BitVectorBinary constant defined both for 32 and 64 bits
BlackboxArchetypeShowing the member functions provided by all blackbox matrix classes
BlackboxBlockContainerNo doc
BlackboxBlockContainerBaseA base class for BlackboxBlockContainer
BlackboxBlockContainerRecordNo doc
BlackboxContainerLimited doc so far
BlackboxContainerBaseA base class for BlackboxContainer
BlackboxContainerSymmetricSee base class for doc
BlackboxContainerSymmetrizeSymmetrizing iterator (for rank computations)
BlackboxFactoryA tool for computations with integer and rational matrices
BlackboxInterfaceThis blackbox base class exists solely to aid documentation organization
BlackboxSpecifierBlackboxSpecifier
BlasBlackboxDense matrix representation for BLAS based elimination
BlasMatrixDense matrix representation
BlasMatrixDomainInterface for all functionnalities provided for BlasMatrix
BlasMatrixDomainAddinC += A
BlasMatrixDomainSubinC -= A
BlasPermutationLapack-style permutation
BlasSubmatrixDense Submatrix representation
BlockHankelLiftingContainerBlock Hankel LiftingContianer
BlockLanczosSolverBlock Lanczos iteration
BlockMasseyDomainCompute the linear generator of a sequence of matrices
BlockRingElements are wrapped BlasMatrix objects
BlockWiedemannLiftingContainerBlock Wiedemann LiftingContianer
BooleanSwitchBoolean switch object
BooleanSwitchFactoryBoolean switch factory
ButterflySwitching Network based BlackBox Matrix
CekstvSwitchButterfly switch object from preconditioner paper
CekstvSwitchFactoryCekstv switch factory
ChineseRemainder< CRABase >Wrapper around OMP/SEQ version of ChineseRemainderXXX<CRABase>
ChineseRemainderSeqNo doc
CommentatorGive information to user during runtime
CompanionCompanion matrix of a monic polynomial
complexSTL class
ComposeBlackbox of a product: $C = AB$, i.e $Cx \gets A(Bx)$
Compose< _Blackbox, _Blackbox >Specialization for _Blackbox1 = _Blackbox2
ComposeOwnerBlackbox of a product: $C = AB$, i.e $Cx \gets A(Bx)$
ComposeTraitsUsed in ..., for example
ComposeTraits< BlasBlackbox< Field > >Used in smith-binary, for example
basic_string::const_iteratorSTL iterator class
string::const_iteratorSTL iterator class
wstring::const_iteratorSTL iterator class
deque::const_iteratorSTL iterator class
list::const_iteratorSTL iterator class
map::const_iteratorSTL iterator class
multimap::const_iteratorSTL iterator class
set::const_iteratorSTL iterator class
multiset::const_iteratorSTL iterator class
vector::const_iteratorSTL iterator class
basic_string::const_reverse_iteratorSTL iterator class
string::const_reverse_iteratorSTL iterator class
wstring::const_reverse_iteratorSTL iterator class
deque::const_reverse_iteratorSTL iterator class
list::const_reverse_iteratorSTL iterator class
map::const_reverse_iteratorSTL iterator class
multimap::const_reverse_iteratorSTL iterator class
set::const_reverse_iteratorSTL iterator class
multiset::const_reverse_iteratorSTL iterator class
vector::const_reverse_iteratorSTL iterator class
ConstantVectorStreamConstant vector factory
BlasSubmatrix::ConstIndexedIteratorRaw Indexed Iterator (const version)
BlasSubmatrix::ConstIteratorRaw Iterators (const version)
DenseContainerLimited doc so far
DenseRowsMatrixDense row-wise matrix container
dequeSTL class
DiagonalRandom diagonal matrices are used heavily as preconditioners
Diagonal< _Field, VectorCategories::DenseVectorTag >Specialization of Diagonal for application to dense vectors
Diagonal< _Field, VectorCategories::SparseAssociativeVectorTag >Specialization of Diagonal for application to sparse associative vectors
Diagonal< _Field, VectorCategories::SparseSequenceVectorTag >Specialization of Diagonal for application to sparse sequence vectors
DifBlackbox of a difference: C := A - B, i.e Cx = Ax - Bx
DiophantineSolverDiophantineSolver<QSolver> creates a diophantine solver using a QSolver to generate rational solutions
DirectSumIf C = DirectSum(A, B) and y = xA and z = wB, then (y,z) = (x,w)C
DixonLiftingContainerDixon Lifting Container
domain_errorSTL class
DotProductDomain< Modular< uint16_t > >Specialization of DotProductDomain for unsigned short modular field
DotProductDomain< Modular< uint32_t > >Specialization of DotProductDomain for uint32_t modular field
DotProductDomain< Modular< uint8_t > >Specialization of DotProductDomain for unsigned short modular field
DotProductDomain< ModularBalanced< double > >Specialization of DotProductDomain
EarlyMultipCRANO DOC
EarlySingleCRANO DOC
BlockRing::ElementDefault constructable wrapper for BlasMatrix
ElementAbstractAbstract element base class, a technicality
ElementArchetypeField and Ring element interface specification and archetypical instance class
ElementEnvelopeAdaptor from archetypical interface to abstract interface, a technicality
EliminationSpecifierEliminationSpecifier
EliminatorElimination system
exceptionSTL class
BBcharpoly::FactorMultNo doc
ios_base::failureSTL class
FieldAbstractField base class
FieldArchetypeField specification and archetypical instance
FieldAXPYFieldAXPY object
FieldAXPY< Modular< _Element > >Specialization of FieldAXPY for parameterized modular field
FieldAXPY< Modular< uint16_t > >Specialization of FieldAXPY for uint16_t modular field
FieldAXPY< Modular< uint32_t > >Specialization of FieldAXPY for unsigned short modular field
FieldAXPY< Modular< uint8_t > >Specialization of FieldAXPY for uint8_t modular field
FieldAXPY< ModularBalanced< double > >Specialization of FieldAXPY
FieldAXPY< UnparametricField< integer > >NO DOc
FieldEnvelopeDerived class used to implement the field archetypeHelps to minimize code bloat
FieldInterfaceThis field base class exists solely to aid documentation organization
FieldIODummy field for conceptually unclear io
foobarTest 1: Invariant factors of random dense matrices
fstreamSTL class
FullMultipBlasMatCRANO DOC
FullMultipCRANO DOC..
FullMultipFixedCRAChinese Remaindering Algorithm for multiple residues
GaussDomainRepository of functions for rank by elimination on sparse matrices
GivaroExtensionThis template class is defined to be in phase with the LinBox archetype
GivaroExtension< GivaroGfq >This template class is define just to be in phase with the LinBox archetype
GivaroFieldGive LinBox fields an allure of Givaro FieldsThis class adds the necessary requirements allowing the construction of an extension of a LinBox field or a givaro polynomial of a LinBox field ..
GivaroField< LinBox::GF2 >Give LinBox fields an allure of Givaro FieldsThis class adds the necessary requirements allowing the construction of an extension of a LinBox field
GivaroGfqWrapper of Givaro's GFqDom<int32_t> class
GivaroMontgWrapper of Givaro's Givaro::Montgomery< Givaro::Std32>
GivaroRnsFixedCRANO DOC..
GivaroZpzWrapper of Givaro's ZpzDom
GivPolynomialRingPolynomials
GmpRandomPrimeGenerating random prime integers, using the gmp library
GMPRationalElementElements of GMP_Rationals
HilbertExample of a blackbox that is space efficient, though not time efficient
Hilbert_JIT_EntryThe object needed to build a Hilbert matrix as a JIT matrix
HomMap element of source ring(field) to target ringAn instance of Hom is a homomorphism from a ring of type Source to a ring (usually field) of type Target
Hom< BaseField, GivaroExtension< BaseField > >NO DOC
HybridSpecifierHybridSpecifier
ifstreamSTL class
InconsistentSystemException thrown when the system to be solved is inconsistent
indexDomainClass used for permuting indices
BlasMatrix::IndexedIteratorIndexed Iterator
BlasSubmatrix::IndexedIteratorRaw Indexed Iterator
ZeroOne< _Field >::IndexIteratorIndexIterator
ZeroOne< GF2 >::IndexIteratorIndexIterator
invalid_argumentSTL class
InvalidMatrixInputException class for invalid matrix input
InverseA Blackbox for the inverse
iosSTL class
ios_baseSTL class
istreamSTL class
istringstreamSTL class
BlasSubmatrix::IteratorRaw Iterators
set::iteratorSTL iterator class
ZeroOne< _Field >::IteratorRaw iterator
ZeroOne< GF2 >::IteratorRaw iterator
basic_string::iteratorSTL iterator class
string::iteratorSTL iterator class
wstring::iteratorSTL iterator class
deque::iteratorSTL iterator class
list::iteratorSTL iterator class
multimap::iteratorSTL iterator class
map::iteratorSTL iterator class
multiset::iteratorSTL iterator class
vector::iteratorSTL iterator class
JIT_MatrixExample of a blackbox that is space efficient, though not time efficient
LABlockLanczosSolverBiorthogonalising block Lanczos iteration
LanczosSolverSolve a linear system using the conjugate Lanczos iteration
LastInvariantFactorThis is used in a Smith Form algorithm
length_errorSTL class
LidiaGfqDefines the Galois Field GF(pk)
LinboxErrorBase class for execption handling in Givaro
LinBoxTagStructure for tags
listSTL class
Local2_32Fast arithmetic mod 2^32, including gcd
logic_errorSTL class
LQUPMatrixLQUP factorisation
mapSTL class
MasseyDomainBerlekamp/Massey algorithm
MatrixArchetypeDirectly-represented matrix archetype
MatrixBlackboxMatrix black box
MatrixCategoriesFor specializing matrix arithmetic
MatrixDomainClass of matrix arithmetic functions
MatrixPermutationPermutation classique
MatrixRankCompute the rank of an integer matrix in place over a finite field by Gaussian elimination
MatrixStreamMatrixStream
MatrixStreamReaderAn abstract base class to represent readers for specific formats
MethodMethod specifiers for controlling algorithm choice
MGBlockLanczosSolverBlock Lanczos iteration
ModularPrime fields of positive characteristic implemented directly in LinBox
Modular< double >Standard representation of $\mathbf{Z}/m\mathbf{Z}$
Modular< int16_t >Specialization of Modular to short element type with efficient dot product
Modular< int32_t >Specialization of Modular to int32_t element type with efficient dot product
Modular< int64_t >Specialization of Modular to int64_t element type with efficient dot product
Modular< int8_t >Specialization of Modular to signed 8 bit element type with efficient dot product
Modular< uint16_t >Specialization of class Modular for uint16_t element type
Modular< uint32_t >Specialization of class Modular for uint32_t element type
Modular< uint8_t >Allows compact storage when the modulus is less than 2^8
ModularBalanced< double >Centered representation of $\mathbf{Z}/m\mathbf{Z}$
ModularBalancedRandIterRandom field base element generator
ModularCrookedRandIterRandom field base element generator
ModularRandIterRandom field base element generator
MoorePenroseGeneralized inverse of a blackbox
multimapSTL class
multisetSTL class
MVProductDomainHelper class to allow specializations of certain matrix-vector products
MVProductDomain< Modular< uint16_t > >Specialization of MVProductDomain for uint16_t modular field
MVProductDomain< Modular< uint32_t > >Specialization of MVProductDomain for uint32_t modular field
MVProductDomain< Modular< uint8_t > >Specialization of MVProductDomain for uint8_t modular field
NoHomErrorError object for attempt to establish a Hom that cannot exist
NonzeroRandIterRandom iterator for nonzero random numbers
NTL_PID_zz_pExtend Wrapper of zz_p from NTL
NTL_ZZInteger ring
NTL_zz_pLong ints modulo a positive integer
NTL_ZZ_pWrapper of zz_p from NTL
NTL_zz_pEZz_pE Define a parameterized class to easily handle UnparametricField<NTL::zz_pE> field
NTL_ZZ_pEWrapper of ZZ_pE from NTL Define a parameterized class to handle easily UnparametricField<NTL::ZZ_pE> field
NTL_zz_pXRing (in fact, a unique factorization domain) of polynomial with coefficients in class NTL_zz_p (integers mod a wordsize prime)
NTL_ZZ_pXRing (in fact, a unique factorization domain) of polynomial with coefficients in class NTL_ZZ_p (integers mod a wordsize prime)
NullMatrixThis is a representation of the 0 by 0 empty matrix which does not occupy memory
ofstreamSTL class
OneInvariantFactorLimited doc so far
ostreamSTL class
ostringstreamSTL class
out_of_rangeSTL class
overflow_errorSTL class
PairPair of I and T : struct { column index, value }
ParamFuzzyAbstract parameterized field of "fuzzy" doubles
PermutationSize is n
PID_doubleNO DOC
PID_integerDomain for integer operations
PIR_ntl_ZZ_pExtend Wrapper of ZZ_p from NTL
PolynomialBBRepresent the matrix P(A) where A is a blackbox and P a polynomial
PolynomialBBOwnerRepresent the matrix P(A) where A is a blackbox and P a polynomial
PowerGaussDomainRepository of functions for rank modulo a prime power by elimination on sparse matrices
PowerOfTwoModularRing of elements modulo some power of two
PreconditionFailedA precondtion failed
PrimeStreamPrime number stream
priority_queueSTL class
queueSTL class
PowerOfTwoModular::RandIterRandom iterator generator type
RandIterAbstractRandom field element generator
RandIterArchetypeRandom field element generator archetype
RandIterEnvelopeRandom field base element generator
RandomDenseMatrixRandom Dense Matrix builder
RandomDenseStreamRandom dense vector stream
RandomDenseStream< Field, _Vector, RandIter, VectorCategories::DenseVectorTag >Specialization of random dense stream for dense vectors
RandomIntegerIterRandom Integer Iterator
RandomIntegerIteratorRandom Prime Generator
RandomPrimeIterRandom Prime Iterator
RandomPrimeIteratorRandom Prime Generator
RandomSparseStreamRandom sparse vector stream
RandomSparseStream< Field, _Vector, RandIter, VectorCategories::DenseVectorTag >Specialization of RandomSparseStream for dense vectors
RandomSparseStream< Field, _Vector, RandIter, VectorCategories::SparseAssociativeVectorTag >Specialization of RandomSparseStream for sparse associative vectors
RandomSparseStream< Field, _Vector, RandIter, VectorCategories::SparseParallelVectorTag >Specialization of RandomSparseStream for sparse parallel vectors
RandomSparseStream< Field, _Vector, RandIter, VectorCategories::SparseSequenceVectorTag >Specialization of RandomSparseStream for sparse sequence vectors
range_errorSTL class
RankBuilderRandom method for constructing rank
RationalReconstructionLimited doc so far
RationalRemainderChinese remainder of rationals
RationalRemainder2Chinese remainder of rationals
RationalSolverInterface for the different specialization of p-adic lifting based solvers
RationalSolver< Ring, Field, RandomPrime, BlockHankelTraits >Block Hankel
RationalSolver< Ring, Field, RandomPrime, BlockWiedemannTraits >Partial specialization of p-adic based solver with block Wiedemann algorithm
RationalSolver< Ring, Field, RandomPrime, DixonTraits >Partial specialization of p-adic based solver with Dixon algorithm
RationalSolver< Ring, Field, RandomPrime, SparseEliminationTraits >Sparse LU
RationalSolver< Ring, Field, RandomPrime, WanTraits >Solver using a hybrid Numeric/Symbolic computation
RationalSolver< Ring, Field, RandomPrime, WiedemannTraits >Partial specialization of p-adic based solver with Wiedemann algorithm
RawVectorCanonical vector types
RebindUsed in support of Hom, MatrixHom
multimap::reverse_iteratorSTL iterator class
vector::reverse_iteratorSTL iterator class
deque::reverse_iteratorSTL iterator class
map::reverse_iteratorSTL iterator class
string::reverse_iteratorSTL iterator class
wstring::reverse_iteratorSTL iterator class
basic_string::reverse_iteratorSTL iterator class
list::reverse_iteratorSTL iterator class
set::reverse_iteratorSTL iterator class
multiset::reverse_iteratorSTL iterator class
ReverseVectorReverse vector class This class wraps an existing vector type and reverses its direction
RingAbstractAbstract ring base class
RingArchetypeSpecification and archetypic instance for the ring interfaceThe RingArchetype and its encapsulated element class contain pointers to the RingAbstract and its encapsulated ring element, respectively
RingCategoriesSome basic information about each field or ring
RingEnvelopeImplement the ring archetype to minimize code bloat
RingInterfaceThis ring base class exists solely to aid documentation organization
RNSRNS
runtime_errorSTL class
ScalarMatrixBlackbox for aI
setSTL class
SigmaBasisImplementation of $\sigma$-basis (minimal basis)
SmithFormBinaryCompute Smith form
SmithFormIliopoulosThis is Iliopoulos' algorithm do diagonalize
SmithFormLocalSmith normal form (invariant factors) of a matrix over a local ring
SolveFailedException thrown when the computed solution vector is not a true solution to the system, but none of the problems cited below exist
SolverTraitsSolver traits
Sparse_VectorVector< Pair<T,I> > and actualsize
SparseLULiftingContainerSparseLULiftingContainer
SparseMatrixVector of sparse rows
SparseMatrixBaseSparse matrix container This class acts as a generic row-wise container for sparse matrices
SparseMatrixFactorySparse matrix factory This class inherits BlackboxFactory and provides a method for using a SparseMatrixBase object with integer or rational data type as input to the high-level integer and rational solutions functions
SquarizeTranspose matrix without copying
stackSTL class
StandardBasisStreamStream for $e_1,\cdots,e_n$
StandardBasisStream< Field, _Vector, VectorCategories::DenseVectorTag >Specialization of standard basis stream for dense vectors
StandardBasisStream< Field, _Vector, VectorCategories::SparseAssociativeVectorTag >Specialization of standard basis stream for sparse associative vectors
StandardBasisStream< Field, _Vector, VectorCategories::SparseParallelVectorTag >Specialization of standard basis stream for sparse parallel vectors
StandardBasisStream< Field, _Vector, VectorCategories::SparseSequenceVectorTag >Specialization of standard basis stream for sparse sequence vectors
stringSTL class
stringstreamSTL class
SubiteratorSubvector iterator class provides striding iterators
SubmatrixLeading principal minor of existing matrix without copying
Submatrix< Blackbox, VectorCategories::DenseVectorTag >Specialization for dense vectors
Submatrix< Blackbox, VectorCategories::DenseZeroOneVectorTag >Specialization for dense ZeroOne vectors
SubmatrixOwner< Blackbox, VectorCategories::DenseVectorTag >Specialization for dense vectors
SubvectorDense subvectorThis class provides a statically sized subvector of a random access container (such as std::vector, deque)
SumBlackbox of a matrix sum without copying
SumOwnerBlackbox of a matrix sum without copying
SylvesterThis is a representation of the Sylvester matrix of two polynomials
ToeplitzThis is the blackbox representation of a Toeplitz matrix
Toeplitz< typename _PField::CoeffField, _PField >Specialization for when the field of matrix elements is the same as the coefficient field of the polynomial field
TransposeTranspose matrix without copying
TransposedBlasMatrixTransposedBlasMatrix
TransposedBlasMatrix< TransposedBlasMatrix< Matrix > >TransposedBlasMatrix
TransposeMatrixMatrix transpose
TransposeOwnerTranspose matrix without copying
TriangularBlasMatrixTriangular BLAS matrix
TriplesBBWrapper for NAG Sparse Matrix format
underflow_errorSTL class
UnparametricRandIterUnparameterized random field element generator template
UnparametricRandIter< NTL::ZZ_p >Constructor for random field element generator
valarraySTL class
vectorSTL class
VectorCategoriesList of vector categories
VectorFractionVectorFraction<Domain> is a vector of rational elements with common reduced denominator
VectorStreamVector factory
VectorTraitsVector traits template structure
wfstreamSTL class
WiedemannLiftingContainerWiedemann LiftingContianer
WiedemannSolverLinear system solvers based on Wiedemann's method
wifstreamSTL class
wiosSTL class
wistreamSTL class
wistringstreamSTL class
wofstreamSTL class
wostreamSTL class
wostringstreamSTL class
wstringSTL class
wstringstreamSTL class
ZeroOne< _Field >Time and space efficient representation of sparse {0,1}-matrices
ZeroOne< GF2 >Time and space efficient representation of sparse matrices over GF2
ZOQuadA class of striped or block-decomposed zero-one matrices