 BitVector | Binary constant defined both for 32 and 64 bits |
 BlackboxArchetype | Showing the member functions provided by all blackbox matrix classes |
  MatrixBlackbox< _Field, _Matrix, _Vector > | Matrix black box |
 BlackboxBlockContainerBase< _Field, _Blackbox > | A base class for BlackboxBlockContainer |
  BlackboxBlockContainer< _Field, _Blackbox > | No doc |
  BlackboxBlockContainerRecord< _Field, _Blackbox > | No doc |
 BlackboxContainerBase< Field, Blackbox > | A base class for BlackboxContainer |
 BlackboxContainerBase< Field, _Blackbox > | |
  BlackboxContainer< Field, _Blackbox, RandIter > | Limited doc so far |
  BlackboxContainerSymmetric< Field, _Blackbox, RandIter > | See base class for doc |
  BlackboxContainerSymmetrize< Field, _Blackbox, RandIter > | Symmetrizing iterator (for rank computations) |
 BlackboxContainerBase< Field, Vector > | |
  DenseContainer< Field, Vector, RandIter > | Limited doc so far |
 BlackboxFactory< Field, Blackbox > | A tool for computations with integer and rational matrices |
 BlackboxFactory< Field, SparseMatrix< Field, Row > > | |
  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 |
 BlackboxSpecifier | BlackboxSpecifier |
 BlasMatrix< _Field > | Dense matrix representation |
  TriangularBlasMatrix< _Field > | Triangular BLAS matrix |
 BlasMatrix< Domain > | |
 BlasMatrix< MultiModDouble > | No Doc |
 BlasMatrixDomain< Field > | Interface for all functionnalities provided for BlasMatrix |
 BlasMatrixDomainAddin< Field, Operand1, Operand2 > | C += A |
 BlasMatrixDomainInv< MultiModDouble, BlasMatrix< MultiModDouble > > | Specialisation for MultiModDouble |
 BlasMatrixDomainSubin< Field, Operand1, Operand2 > | C -= A |
 BlasPermutation< _UnsignedInt > | Lapack-style permutation |
 BlasSubmatrix< _Field > | Dense Submatrix representation |
  Submatrix< BlasMatrix< _Field >, VectorCategories::DenseVectorTag > | Specialization for BlasMatrix |
 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 |
 BlockWiedemannLiftingContainer< _Ring, _Field, _IMatrix, _FMatrix > | Block Wiedemann LiftingContianer |
 BooleanSwitch | Boolean switch object |
 BooleanSwitchFactory | Boolean switch factory |
 Butterfly< _Field, Switch > | Switching Network based BlackBox Matrix |
 CekstvSwitch< Field > | Butterfly switch object from preconditioner paper |
 CekstvSwitchFactory< Field > | Cekstv switch factory |
 ChineseRemainderSeq< CRABase > | No doc |
  ChineseRemainder< CRABase > | Wrapper around OMP/SEQ version of ChineseRemainderXXX<CRABase> |
 ClassifyRing< Field > | Default ring category |
 Commentator | Give information to user during runtime |
 Compose< _Blackbox1, _Blackbox2 > | Blackbox of a product: , i.e  |
 Compose< _Blackbox, _Blackbox > | Specialization for _Blackbox1 = _Blackbox2 |
 ComposeOwner< _Blackbox1, _Blackbox2 > | Blackbox of a product: , i.e  |
 ComposeTraits< IMatrix > | Used in ..., for example |
 ComposeTraits< BlasMatrix< Field > > | Used in smith-binary, for example |
 BlasSubmatrix< _Field >::ConstIndexedIterator | Raw Indexed Iterator (const version) |
 BlasSubmatrix< _Field >::ConstIterator | Raw Iterators (const version) |
 CRASpecifier | CRASpecifier |
 CRATraits | Solve using CRA (iterations uses SolveMethod) |
 DenseRowsMatrix< _Row > | Dense row-wise matrix container |
 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 |
 DirectSum< Companion< _Field > > | |
 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 |
 EarlySingleCRA< Domain_Type > | NO DOC |
  EarlyMultipCRA< Domain_Type > | NO DOC |
 EchelonFormDomain< Field > | Echelon form domain |
 BlockRing< _Field >::Element | Default constructable wrapper for BlasMatrix |
 ElementAbstract | Abstract element base class, a technicality |
  ElementEnvelope< Ring > | |
  ElementEnvelope< Field > | Adaptor from archetypical interface to abstract interface, a technicality |
 ElementArchetype | Field and Ring element interface specification and archetypical instance class |
 EliminationSpecifier | EliminationSpecifier |
 Eliminator< Field, Matrix > | Elimination system |
 Exception | This is the exception class in LinBox |
  algoException | Algorithmic exception |
  BadInputException | The input is not as expected |
  IrrecuperableException | Something bad an unexpected happened |
  NotImplementedYetException | Not implemented yet |
 FieldAbstract | Field base class |
  FieldEnvelope< Ring > | |
   RingEnvelope< Ring > | Implement the ring archetype to minimize code bloat |
  FieldEnvelope< Field > | Derived class used to implement the field archetypeHelps to minimize code bloat |
  RingAbstract | Abstract ring base class |
   RingEnvelope< Ring > | Implement the ring archetype to minimize code bloat |
 FieldAXPY< Field > | FieldAXPY object |
 FieldAXPY< Domain > | |
 FieldAXPY< GF2 > | |
 FieldAXPY< GivaroZpz< Givaro::Std16 > > | |
 FieldAXPY< GivaroZpz< Givaro::Std32 > > | |
 FieldAXPY< Modular< _Element > > | Specialization of FieldAXPY for parameterized modular field |
 FieldAXPY< Modular< double > > | |
 FieldAXPY< Modular< float > > | |
 FieldAXPY< Modular< int16_t > > | |
 FieldAXPY< Modular< int32_t > > | |
 FieldAXPY< Modular< int64_t > > | |
 FieldAXPY< Modular< int8_t > > | |
 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< ModularBalanced< float > > | |
 FieldAXPY< ModularBalanced< int32_t > > | |
 FieldAXPY< ModularBalanced< int64_t > > | |
 FieldAXPY< ModularCrooked< double > > | |
 FieldAXPY< PIR_ntl_ZZ_p > | |
 FieldAXPY< PIRModular< int32_t > > | |
 FieldAXPY< UnparametricField< integer > > | NO DOc |
 FieldInterface | This field base class exists solely to aid documentation organization |
  GivaroZpz< Givaro::Std16 > | |
  GivaroZpz< Givaro::Std32 > | |
  BlockRing< _Field > | Elements are wrapped BlasMatrix objects |
  FieldArchetype | Field specification and archetypical instance |
   RingArchetype | Specification and archetypic instance for the ring interfaceThe RingArchetype and its encapsulated element class contain pointers to the RingAbstract and its encapsulated ring element, respectively |
  GivaroExtension< BaseField > | This template class is defined to be in phase with the LinBox archetype |
  GivaroExtension< LinBox::GivaroGfq > | This template class is define just to be in phase with the LinBox archetype |
  GivaroGfq | Wrapper of Givaro's GFqDom<int32_t> class |
  GivaroMontg | Wrapper of Givaro's Givaro::Montgomery< Givaro::Std32> |
  GivaroZpz< TAG > | Wrapper of Givaro's ZpzDom |
  LidiaGfq | Defines the Galois Field GF(pk) |
  Modular< double > | Standard representation of  |
  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  |
  ParamFuzzy | Abstract parameterized field of "fuzzy" doubles |
 FieldIO< _Element > | Dummy field for conceptually unclear io |
 FieldTraits< Field > | FieldTrait |
 foobar< LocalPIR > | Test 1: Invariant factors of random dense matrices |
 FullMultipCRA< Domain_Type > | NO DOC.. |
  EarlyMultipCRA< Domain_Type > | NO DOC |
  FullMultipBlasMatCRA< 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 |
  PowerGaussDomain< _Field > | Repository of functions for rank modulo a prime power by elimination on sparse matrices |
 GenericTag | Generic ring |
  IntegerTag | If it is isomorphic to Z |
  ModularTag | If it is isomorphic to Z/mZ, for some m or its extensions |
  RationalTag | If it is isomorphic to Q |
 VectorCategories::GenericVectorTag | Generic vector (no assumption is made) |
  VectorCategories::SparseVectorTag | Sparse vectors (general) |
   VectorCategories::SparseAssociativeVectorTag | Sparse vectors (general) |
   VectorCategories::SparseParallelVectorTag | Sparse vectors (general) |
   VectorCategories::SparseSequenceVectorTag | Sparse vectors (general) |
  VectorCategories::SparseZeroOneVectorTag | Sparse GF2 vectors |
   VectorCategories::DenseVectorTag | Dense vector (GF2 and general) |
    VectorCategories::DenseZeroOneVectorTag | Sparse vectors (general) |
 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 |
 GivaroRnsFixedCRA< Domain_Type > | NO DOC.. |
 GivPolynomialRing< Domain, StorageTag > | Polynomials |
 GmpRandomPrime | Generating random prime integers, using the gmp library |
 GMPRationalElement | Elements of GMP_Rationals |
 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 |
 HybridSpecifier | HybridSpecifier |
 IMLTraits | IML wrapper |
 InconsistentSystem< Vector > | Exception thrown when the system to be solved is inconsistent |
 indexDomain | Class used for permuting indices |
 BlasMatrix< _Field >::IndexedIterator | Indexed Iterator |
 BlasSubmatrix< _Field >::IndexedIterator | Raw Indexed Iterator |
 ZeroOne< _Field >::IndexIterator | IndexIterator |
 ZeroOne< GF2 >::IndexIterator | IndexIterator |
 InvalidMatrixInput | Exception class for invalid matrix input |
 Inverse< Blackbox > | A Blackbox for the inverse |
 BlasSubmatrix< _Field >::Iterator | Raw Iterators |
 ZeroOne< _Field >::Iterator | Raw iterator |
 ZeroOne< GF2 >::Iterator | Raw iterator |
 JIT_Matrix< _Field, JIT_EntryGenerator > | Example of a blackbox that is space efficient, though not time efficient |
 JIT_Matrix< _Field, Hilbert_JIT_Entry< _Field > > | |
  Hilbert< _Field > | 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 |
 LargeDouble | NO DOC |
 LastInvariantFactor< _Ring, _Solver > | This is used in a Smith Form algorithm |
 latticeMethod | NTL methods |
 LinboxError | Base class for execption handling in LinBox |
 LinBoxTag | Structure for tags |
 Local2_32 | Fast arithmetic mod 2^32, including gcd |
 LQUPMatrix< Field > | LQUP factorisation |
 MasseyDomain< Field, Sequence > | Berlekamp/Massey algorithm |
 MatrixArchetype< _Element > | Directly-represented matrix archetype |
 MatrixCategories | For specializing matrix arithmetic |
 MatrixDomain< GF2 > | Specialization of MatrixDomain for GF2 |
 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 |
 Method | Method specifiers for controlling algorithm choice |
 MGBlockLanczosSolver< Field, Matrix > | Block Lanczos iteration |
 Modular< _Element > | Prime fields of positive characteristic implemented directly in LinBox |
 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 |
  MatrixDomain< Field > | Class of matrix arithmetic functions |
 MVProductDomain< Domain > | |
  MatrixDomain< Domain > | |
 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 |
 naive | Toom-Cook method |
 NoHomError | Error object for attempt to establish a Hom that cannot exist |
 NonzeroRandIter< Field, RandIter > | Random iterator for nonzero random numbers |
 NTL_ZZ | Integer ring |
 NTL_zz_p | Long ints modulo a positive integer |
  NTL_PID_zz_p | Extend Wrapper of zz_p from NTL |
 NTL_ZZ_p | Wrapper of zz_p from NTL |
  PIR_ntl_ZZ_p | Extend Wrapper of ZZ_p from NTL |
 NTL_ZZ_pE | Wrapper of ZZ_pE from NTL Define a parameterized class to handle easily UnparametricField<NTL::ZZ_pE> field |
 NTL_zz_pE_Initialiser | Use ZZ_pEBak mechanism too ? |
  NTL_zz_pE | Zz_pE Define a parameterized class to easily handle UnparametricField<NTL::zz_pE> field |
 NTL_zz_pX | Ring (in fact, a unique factorization domain) of polynomial with coefficients in class NTL_zz_p (integers mod a wordsize prime) |
 NTL_ZZ_pX | Ring (in fact, a unique factorization domain) of polynomial with coefficients in class NTL_ZZ_p (integers mod a wordsize prime) |
 NullMatrix | This 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 } |
 Permutation< _Field, _Storage > | Size is n |
 PID_double | NO DOC |
 PID_integer | Domain for integer operations |
 PlotStyle::Plot | What style of graphic : histogram ? graph ? |
 PlotData< NAM > | The raw data to plot |
 PlotGraph< NAM > | The graph |
 PlotStyle | Represents 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 |
 PowerGaussDomainPowerOfTwo< UnsignedIntType > | Repository of functions for rank modulo a prime power by elimination on sparse matrices |
 PowerOfTwoModular< Ints > | Ring of elements modulo some power of two |
 PreconditionFailed | A precondition failed |
 PrimeStream< Element > | Prime number stream |
 PowerOfTwoModular< Ints >::RandIter | Random iterator generator type |
 RandIterAbstract | Random field element generator |
  RandIterEnvelope< Field > | Random field base element generator |
 RandIterArchetype | Random field element generator archetype |
 RandomDenseMatrix< Randiter, Field > | Random Dense Matrix builder |
 RandomIntegerIter< _Unsigned > | Random Integer Iterator |
 RandomIntegerIterator< _Unsigned > | Random Prime Generator |
 RandomPrimeIter | Random Prime Iterator |
 RandomPrimeIterator | Random Prime Generator |
 RankBuilder | Random 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 |
 RawVector< Element > | Canonical vector types |
 RawVector< Ring::Element > | |
  Vector< Ring > | Vector ?? |
 Rebind< XXX, U > | Used in support of Hom, MatrixHom |
 Rebind< std::vector< T >, U > | Rebind |
 ReverseVector< Vector > | Reverse vector class This class wraps an existing vector type and reverses its direction |
 RingInterface | This ring base class exists solely to aid documentation organization |
 RNS< Unsigned > | RNS |
 ScalarMatrix< _Field > | Blackbox for aI |
 SigmaBasis< _Field > | Implementation of -basis (minimal basis) |
 SmithFormBinary< _Ring, _oneInvariantFactor, _Rank > | Compute Smith form |
 SmithFormIliopoulos | This is Iliopoulos' algorithm do diagonalize |
 SmithFormLocal< LocalPID > | Smith normal form (invariant factors) of a matrix over a local ring |
 SolveFailed | Exception thrown when the computed solution vector is not a true solution to the system, but none of the problems cited below exist |
 SolverTraits | Solver traits |
 Sparse_Vector< T, I > | Vector< Pair<T,I> > and actualsize |
 SparseLULiftingContainer< _Ring, _Field, _IMatrix, _FMatrix > | SparseLULiftingContainer |
 SparseMatrixBase< _Element, _Row, Trait > | Sparse matrix container This class acts as a generic row-wise container for sparse matrices |
 SparseMatrixBase< _Field::Element, _Row > | |
  SparseMatrix< _Field, _Row > | Vector of sparse rows |
 Squarize< Blackbox > | Transpose matrix without copying |
 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 |
 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::Term | What format the plot should be in? |
 TernaryLattice | NO DOC |
 Toeplitz< _CField, _PField > | This is the blackbox representation of a Toeplitz matrix |
 Toeplitz< _Field > | |
 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 |
 TriplesBB< _Field > | Wrapper for NAG Sparse Matrix format |
  Companion< _Field > | Companion matrix of a monic polynomial |
 UnparametricRandIter< K > | Unparameterized random field element generator template |
 UnparametricRandIter< NTL::ZZ_p > | Constructor for random field element generator |
 VectorCategories | List of vector categories |
 VectorFraction< Domain > | VectorFraction<Domain> is a vector of rational elements with common reduced denominator |
 VectorStream< _Vector > | Vector factory |
  ConstantVectorStream< _Vector > | Constant vector factory |
  RandomDenseStream< Field, _Vector, RandIter, Trait > | Random dense vector stream |
  RandomDenseStream< Field, _Vector, RandIter, VectorCategories::DenseVectorTag > | Specialization of random dense stream for dense vectors |
  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 |
  StandardBasisStream< Field, _Vector, Trait > | Stream for  |
  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 |
 VectorStream< BitVector > | |
 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 |