linbox
Data Structures
Here are the data structures with brief descriptions:
BitVectorBinary constant defined both for 32 and 64 bits
BlackboxArchetypeShowing the member functions provided by all blackbox matrix classes
BlackboxBlockContainer< _Field, _Blackbox >No doc
BlackboxBlockContainerBase< _Field, _Blackbox >A base class for BlackboxBlockContainer
BlackboxBlockContainerRecord< _Field, _Blackbox >No doc
BlackboxContainer< Field, _Blackbox, RandIter >Limited doc so far
BlackboxContainerBase< Field, Blackbox >A base class for BlackboxContainer
BlackboxContainerSymmetric< Field, _Blackbox, RandIter >See base class for doc
BlackboxContainerSymmetrize< Field, _Blackbox, RandIter >Symmetrizing iterator (for rank computations)
BlackboxFactory< Field, Blackbox >A tool for computations with integer and rational matrices
BlackboxInterfaceThis blackbox base class exists solely to aid documentation organization
BlackboxSpecifierBlackboxSpecifier
BlasBlackbox< _Field >Dense matrix representation for BLAS based elimination
BlasMatrix< _Element >BlasMatrix
BlasMatrixDomain< Field >Interface for all functionnalities provided for BlasMatrix
BlasMatrixDomainAddin< Field, Operand1, Operand2 >C += A
BlasMatrixDomainSubin< Field, Operand1, Operand2 >C -= A
BlasPermutation< _UnsignedInt >Lapack-style permutation
BlasTagTAG for triangular blas matrix
BlockHankelLiftingContainer< _Ring, _Field, _IMatrix, _FMatrix, _Block >Block Hankel LiftingContianer
BlockLanczosSolver< Field, Matrix >Block Lanczos iteration
BlockMasseyDomain< _Field, _Sequence >Compute the linear generator of a sequence of matrices
BlockRing< _Field >Elements are wrapped BlasMatrix objects
BlockWiedemannLiftingContainer< _Ring, _Field, _IMatrix, _FMatrix >Block Wiedemann LiftingContianer
BooleanSwitchBoolean switch object
BooleanSwitchFactoryBoolean switch factory
Butterfly< _Field, Switch >Switching Network based BlackBox Matrix
CekstvSwitch< Field >Butterfly switch object from preconditioner paper
CekstvSwitchFactory< Field >Cekstv switch factory
ChineseRemainder< CRABase >Wrapper around OMP/SEQ version of ChineseRemainderXXX<CRABase>
ChineseRemainderSeq< CRABase >No doc
DenseMatrixBase< _Element >::ColIteratorCol Iterator
CommentatorGive information to user during runtime
Companion< _Field >Companion matrix of a monic polynomial
Compose< _Blackbox1, _Blackbox2 >Blackbox of a product: $C = AB$, i.e $Cx \gets A(Bx)$
Compose< _Blackbox, _Blackbox >Specialization for _Blackbox1 = _Blackbox2
ComposeOwner< _Blackbox1, _Blackbox2 >Blackbox of a product: $C = AB$, i.e $Cx \gets A(Bx)$
ComposeTraits< IMatrix >Used in ..., for example
ComposeTraits< DenseMatrix< Field > >Used in smith-binary, for example
ConstantVectorStream< _Vector >Constant vector factory
DenseMatrixBase< _Element >::ConstColIteratorConst Col Iterator
DenseSubmatrix< _Element >::ConstRawIndexedIteratorRaw Indexed Iterator (const version)
DenseMatrixBase< _Element >::ConstRawIndexedIteratorConst Raw Indexed Iterator
DenseSubmatrix< _Element >::ConstRawIteratorRaw Iterators (const version)
DenseMatrixBase< _Element >::ConstRowIteratorConst Row Iterator
DenseContainer< Field, Vector, RandIter >Limited doc so far
DenseMatrix< _Field >Blackbox interface to dense matrix representation
DenseMatrixBase< _Element >LinBox dense matrix template
DenseMatrixFactory< Field, BElement >Dense matrix factory
DenseRowsMatrix< _Row >Dense row-wise matrix container
DenseSubmatrix< _Element >Submatrix of a dense matrix
Diagonal< Field, Trait >Random 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
Dif< _Blackbox1, _Blackbox2 >Blackbox of a difference: C := A - B, i.e Cx = Ax - Bx
DiophantineSolver< QSolver >DiophantineSolver<QSolver> creates a diophantine solver using a QSolver to generate rational solutions
DirectSum< _Blackbox1, _Blackbox2 >If C = DirectSum(A, B) and y = xA and z = wB, then (y,z) = (x,w)C
DixonLiftingContainer< _Ring, _Field, _IMatrix, _FMatrix >Dixon Lifting Container
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
EarlyMultipCRA< Domain_Type >NO DOC
EarlySingleCRA< Domain_Type >NO DOC
BlockRing< _Field >::ElementDefault constructable wrapper for BlasMatrix
ElementAbstractAbstract element base class, a technicality
ElementArchetypeField and Ring element interface specification and archetypical instance class
ElementEnvelope< Field >Adaptor from archetypical interface to abstract interface, a technicality
EliminationSpecifierEliminationSpecifier
Eliminator< Field, Matrix >Elimination system
FieldAbstractField base class
FieldArchetypeField specification and archetypical instance
FieldAXPY< Field >FieldAXPY 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
FieldEnvelope< Field >Derived class used to implement the field archetypeHelps to minimize code bloat
FieldInterfaceThis field base class exists solely to aid documentation organization
FieldIO< _Element >Dummy field for conceptually unclear io
foobar< LocalPIR >Test 1: Invariant factors of random dense matrices
FullMultipBlasMatCRA< Domain_Type >NO DOC
FullMultipCRA< Domain_Type >NO DOC..
FullMultipFixedCRA< Domain_Type >Chinese Remaindering Algorithm for multiple residues
GaussDomain< _Field >Repository of functions for rank by elimination on sparse matrices
GivaroExtension< BaseField >This 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
GivaroField< BaseField >Give 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>
GivaroRnsFixedCRA< Domain_Type >NO DOC..
GivaroZpz< TAG >Wrapper of Givaro's ZpzDom
GivPolynomialRing< Domain, StorageTag >Polynomials
GmpRandomPrimeGenerating random prime integers, using the gmp library
GMPRationalElementElements of GMP_Rationals
Hilbert< _Field >Example of a blackbox that is space efficient, though not time efficient
Hilbert_JIT_Entry< _Field >The object needed to build a Hilbert matrix as a JIT matrix
Hom< Source, Target >Map 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
InconsistentSystem< Vector >Exception thrown when the system to be solved is inconsistent
indexDomainClass used for permuting indices
InvalidMatrixInputException class for invalid matrix input
Inverse< Blackbox >A Blackbox for the inverse
JIT_Matrix< _Field, JIT_EntryGenerator >Example of a blackbox that is space efficient, though not time efficient
LABlockLanczosSolver< Field, Matrix >Biorthogonalising block Lanczos iteration
LanczosSolver< Field, Vector >Solve a linear system using the conjugate Lanczos iteration
LastInvariantFactor< _Ring, _Solver >This is used in a Smith Form algorithm
LidiaGfqDefines the Galois Field GF(pk)
LinboxErrorBase class for execption handling in Givaro
LinBoxTagStructure for tags
Local2_32Fast arithmetic mod 2^32, including gcd
LQUPMatrix< Field >LQUP factorisation
MasseyDomain< Field, Sequence >Berlekamp/Massey algorithm
MatrixArchetype< _Element >Directly-represented matrix archetype
MatrixBlackbox< _Field, _Matrix, _Vector >Matrix black box
MatrixCategoriesFor specializing matrix arithmetic
MatrixDomain< Field >Class of matrix arithmetic functions
MatrixPermutation< _UnsignedInt >Permutation classique
MatrixRank< _Ring, _Field, _RandomPrime >Compute the rank of an integer matrix in place over a finite field by Gaussian elimination
MatrixStream< Field >MatrixStream
MatrixStreamReader< Field >An abstract base class to represent readers for specific formats
MethodMethod specifiers for controlling algorithm choice
MGBlockLanczosSolver< Field, Matrix >Block Lanczos iteration
Modular< _Element >Prime 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}$
ModularBalancedRandIter< Element >Random field base element generator
ModularCrookedRandIter< Element >Random field base element generator
ModularRandIter< Element >Random field base element generator
MoorePenrose< Blackbox >Generalized inverse of a blackbox
MVProductDomain< Field >Helper 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
NonzeroRandIter< Field, RandIter >Random iterator for nonzero random numbers
NTL_PID_zz_pExtend Wrapper of zz_p from NTL
NTL_ZZInteger ring
NTL_ZZ_pWrapper of zz_p from NTL
NTL_zz_pLong ints modulo a positive integer
NTL_zz_pEFor large cardinality, small prime
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
OneInvariantFactor< _Ring, _LastInvariantFactor, _Compose, _RandomMatrix >Limited doc so far
Pair< I, T >Pair of I and T : struct { column index, value }
ParamFuzzyAbstract parameterized field of "fuzzy" doubles
Permutation< _Field, _Storage >Size is n
PID_doubleNO DOC
PID_integerDomain for integer operations
PIR_ntl_ZZ_pExtend Wrapper of ZZ_p from NTL
PlotStyle::PlotWhat style of graphic : histogram ? graph ?
PlotData< NAM >The raw data to plot
PlotGraph< NAM >The graph
PlotStyleRepresents a table of values to plot
PolynomialBB< Blackbox, Poly >Represent the matrix P(A) where A is a blackbox and P a polynomial
PolynomialBBOwner< Blackbox, Poly >Represent the matrix P(A) where A is a blackbox and P a polynomial
PowerGaussDomain< _Field >Repository of functions for rank modulo a prime power by elimination on sparse matrices
PowerOfTwoModular< Ints >Ring of elements modulo some power of two
PreconditionFailedA precondtion failed
PrimeStream< Element >Prime number stream
PowerOfTwoModular< Ints >::RandIterRandom iterator generator type
RandIterAbstractRandom field element generator
RandIterArchetypeRandom field element generator archetype
RandIterEnvelope< Field >Random field base element generator
RandomDenseMatrix< Randiter, Field >Random Dense Matrix builder
RandomDenseStream< Field, _Vector, RandIter, Trait >Random dense vector stream
RandomDenseStream< Field, _Vector, RandIter, VectorCategories::DenseVectorTag >Specialization of random dense stream for dense vectors
RandomIntegerIter< _Unsigned >Random Integer Iterator
RandomIntegerIterator< _Unsigned >Random Prime Generator
RandomPrimeIterRandom Prime Iterator
RandomPrimeIteratorRandom Prime Generator
RandomSparseStream< Field, _Vector, RandIter, Trait >Random 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
RankBuilderRandom method for constructing rank
RationalReconstruction< _LiftingContainer, RatRecon >Limited doc so far
RationalRemainder< RatCRABase >Chinese remainder of rationals
RationalRemainder2< RatCRABase, RatRecon >Chinese remainder of rationals
RationalSolver< Ring, Field, RandomPrime, MethodTraits >Interface 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
DenseMatrixBase< _Element >::RawIndexedIteratorRaw Indexed Iterator
DenseSubmatrix< _Element >::RawIndexedIteratorRaw Indexed Iterator
ZeroOne< _Field >::RawIndexIteratorRawIndexIterator
ZeroOne< GF2 >::RawIndexIteratorRawIndexIterator
DenseSubmatrix< _Element >::RawIteratorRaw Iterators
ZeroOne< _Field >::RawIteratorRaw iterator
ZeroOne< GF2 >::RawIteratorRaw iterator
RawVector< Element >Canonical vector types
Rebind< XXX, U >Used in support of Hom, MatrixHom
BlasMatrix< _Element >::rebind< _Tp1 >Rebind operator
ReverseVector< Vector >Reverse 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
RingEnvelope< Ring >Implement the ring archetype to minimize code bloat
RingInterfaceThis ring base class exists solely to aid documentation organization
RNS< Unsigned >RNS
DenseMatrixBase< _Element >::RowIteratorRow Iterator
ScalarMatrix< _Field >Blackbox for aI
SigmaBasis< _Field >Implementation of $\sigma$-basis (minimal basis)
SmithFormBinary< _Ring, _oneInvariantFactor, _Rank >Compute Smith form
SmithFormIliopoulosThis is Iliopoulos' algorithm do diagonalize
SmithFormLocal< LocalPID >Smith 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_Vector< T, I >Vector< Pair<T,I> > and actualsize
SparseLULiftingContainer< _Ring, _Field, _IMatrix, _FMatrix >SparseLULiftingContainer
SparseMatrix< _Field, _Row >Vector of sparse rows
SparseMatrixBase< _Element, _Row, Trait >Sparse matrix container This class acts as a generic row-wise container for sparse matrices
SparseMatrixFactory< Field, BElement, Row, BRow >Sparse 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
Squarize< Blackbox >Transpose matrix without copying
StandardBasisStream< Field, _Vector, Trait >Stream 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
Subiterator< Iterator >Subvector iterator class provides striding iterators
Submatrix< Blackbox, Trait >Leading principal minor of existing matrix without copying
Submatrix< Blackbox, VectorCategories::DenseVectorTag >Specialization for dense vectors
Submatrix< Blackbox, VectorCategories::DenseZeroOneVectorTag >Specialization for dense ZeroOne vectors
Submatrix< DenseMatrix< _Field >, VectorCategories::DenseVectorTag >Special case for the submatrix of a dense matrix
SubmatrixOwner< Blackbox, VectorCategories::DenseVectorTag >Specialization for dense vectors
Subvector< Iterator, ConstIterator >Dense subvectorThis class provides a statically sized subvector of a random access container (such as std::vector, deque)
Sum< _Blackbox1, _Blackbox2 >Blackbox of a matrix sum without copying
SumOwner< _Blackbox1, _Blackbox2 >Blackbox of a matrix sum without copying
Sylvester< _Field >This is a representation of the Sylvester matrix of two polynomials
PlotStyle::TermWhat format the plot should be in?
Toeplitz< _CField, _PField >This 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
Transpose< Blackbox >Transpose matrix without copying
TransposedBlasMatrix< Matrix >TransposedBlasMatrix
TransposedBlasMatrix< TransposedBlasMatrix< Matrix > >TransposedBlasMatrix
TransposeMatrix< Matrix, Trait >Matrix transpose
TransposeOwner< Blackbox >Transpose matrix without copying
TriangularBlasMatrix< Element >Triangular BLAS matrix
TriplesBB< _Field >Wrapper for NAG Sparse Matrix format
UnparametricRandIter< K >Unparameterized random field element generator template
VectorCategoriesList of vector categories
VectorFraction< Domain >VectorFraction<Domain> is a vector of rational elements with common reduced denominator
VectorStream< _Vector >Vector factory
VectorTraits< Vector >Vector traits template structure
WiedemannLiftingContainer< _Ring, _Field, _IMatrix, _FMatrix, _FPolynomial >Wiedemann LiftingContianer
WiedemannSolver< Field >Linear system solvers based on Wiedemann's method
ZeroOne< _Field >Time and space efficient representation of sparse {0,1}-matrices
ZeroOne< GF2 >Time and space efficient representation of sparse matrices over GF2
ZOQuad< _Field >A class of striped or block-decomposed zero-one matrices