 LinBox | Namespace in which all linbox code resides |
  BLAS3 | |
   mulMethod | BLAS3 Multiplication methods |
    naive | Toom-Cook method |
  MatrixHom | Limited doc so far. Used in RationalSolver |
  IndexedTags | Limited doc so far |
  RingCategories | Some basic information about each field or ring |
   GenericTag | Generic ring |
   ModularTag | If it is isomorphic to Z/mZ, for some m or its extensions |
   IntegerTag | If it is isomorphic to Z |
   RationalTag | If it is isomorphic to Q |
  Protected | This is the namespace all LinBox internal code is in |
  GetEntryTags | Limited doc so far |
  TraceTags | Undocumented |
  VectorWrapper | Limited doc so far |
  BlackboxBlockContainerBase | A base class for BlackboxBlockContainer |
  BlackboxBlockContainer | No doc |
  BlackboxBlockContainerRecord | No doc |
  BlackboxContainerBase | A base class for BlackboxContainer |
  BlackboxContainerSymmetric | See base class for doc |
  BlackboxContainerSymmetrize | Symmetrizing iterator (for rank computations) |
  BlackboxContainer | Limited doc so far |
  BlasMatrixDomainInv< MultiModDouble, BlasMatrix< MultiModDouble > > | Specialisation for MultiModDouble |
  BlasMatrixDomainSubin | C -= A |
  BlasMatrixDomainAddin | C += A |
  BlasMatrixDomain | Interface for all functionnalities provided for BlasMatrix |
  BlockLanczosSolver | Block Lanczos iteration |
  BlockMasseyDomain | Compute the linear generator of a sequence of matrices |
  ChineseRemainderSeq | No doc |
  ChineseRemainder | Wrapper around OMP/SEQ version of ChineseRemainderXXX<CRABase> |
  EarlyMultipCRA | NO DOC |
  EarlySingleCRA | NO DOC |
  FullMultipFixedCRA | Chinese Remaindering Algorithm for multiple residues |
  FullMultipBlasMatCRA | NO DOC |
  FullMultipCRA | NO DOC.. |
  GivaroRnsFixedCRA | NO DOC.. |
  DenseContainer | Limited doc so far |
  DiophantineSolver | DiophantineSolver<QSolver> creates a diophantine solver using a QSolver to generate rational solutions |
  EchelonFormDomain | Echelon form domain |
  Eliminator | Elimination system |
  GaussDomain | Repository of functions for rank by elimination on sparse matrices |
  LABlockLanczosSolver | Biorthogonalising block Lanczos iteration |
  LanczosSolver | Solve a linear system using the conjugate Lanczos iteration |
  LastInvariantFactor | This is used in a Smith Form algorithm |
  latticeMethod | NTL methods |
  DixonLiftingContainer | Dixon Lifting Container |
  WiedemannLiftingContainer | Wiedemann LiftingContianer |
  BlockWiedemannLiftingContainer | Block Wiedemann LiftingContianer |
  BlockHankelLiftingContainer | Block Hankel LiftingContianer |
  SparseLULiftingContainer | SparseLULiftingContainer |
  LinBoxTag | Structure for tags |
  MasseyDomain | Berlekamp/Massey algorithm |
  MatrixRank | Compute the rank of an integer matrix in place over a finite field by Gaussian elimination |
  MGBlockLanczosSolver | Block Lanczos iteration |
  OneInvariantFactor | Limited doc so far |
  RationalRemainder | Chinese remainder of rationals |
  RationalRemainder2 | Chinese remainder of rationals |
  RationalReconstruction | Limited doc so far |
  RationalSolver | Interface for the different specialization of p-adic lifting based solvers |
  RationalSolver< Ring, Field, RandomPrime, WiedemannTraits > | Partial specialization of p-adic based solver with Wiedemann algorithm |
  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, BlockHankelTraits > | Block Hankel |
  RationalSolver< Ring, Field, RandomPrime, SparseEliminationTraits > | Sparse LU |
  RationalSolver< Ring, Field, RandomPrime, WanTraits > | Solver using a hybrid Numeric/Symbolic computation |
  RNS | RNS |
  TernaryLattice | NO DOC |
  LargeDouble | NO DOC |
  SigmaBasis | Implementation of -basis (minimal basis) |
  SmithFormBinary | Compute Smith form |
  SmithFormIliopoulos | This is Iliopoulos' algorithm do diagonalize |
  SmithFormLocal | Smith normal form (invariant factors) of a matrix over a local ring |
  PowerGaussDomain | Repository of functions for rank modulo a prime power by elimination on sparse matrices |
  PowerGaussDomainPowerOfTwo | Repository of functions for rank modulo a prime power by elimination on sparse matrices |
  VectorFraction | VectorFraction<Domain> is a vector of rational elements with common reduced denominator |
  WiedemannSolver | Linear system solvers based on Wiedemann's method |
  BlackboxArchetype | Showing the member functions provided by all blackbox matrix classes |
  Butterfly | Switching Network based BlackBox Matrix |
  Companion | Companion matrix of a monic polynomial |
  Compose | Blackbox of a product: , i.e  |
  Compose< _Blackbox, _Blackbox > | Specialization for _Blackbox1 = _Blackbox2 |
  ComposeTraits | Used in ..., for example |
  ComposeTraits< BlasMatrix< Field > > | Used in smith-binary, for example |
  ComposeOwner | Blackbox of a product: , i.e  |
  Diagonal | Random diagonal matrices are used heavily as preconditioners |
  Diagonal< _Field, VectorCategories::DenseVectorTag > | Specialization of Diagonal for application to dense vectors |
  Diagonal< _Field, VectorCategories::SparseSequenceVectorTag > | Specialization of Diagonal for application to sparse sequence vectors |
  Diagonal< _Field, VectorCategories::SparseAssociativeVectorTag > | Specialization of Diagonal for application to sparse associative vectors |
  Dif | Blackbox of a difference: C := A - B , i.e Cx = Ax - Bx |
  DirectSum | If C = DirectSum(A, B) and y = xA and z = wB, then (y,z) = (x,w)C |
  BlackboxFactory | A tool for computations with integer and rational matrices |
  Hilbert_JIT_Entry | The object needed to build a Hilbert matrix as a JIT matrix |
  Hilbert | Example of a blackbox that is space efficient, though not time efficient |
  Inverse | A Blackbox for the inverse |
  JIT_Matrix | Example of a blackbox that is space efficient, though not time efficient |
  MatrixBlackbox | Matrix black box |
  MoorePenrose | Generalized inverse of a blackbox |
  Sylvester | This is a representation of the Sylvester matrix of two polynomials |
  NullMatrix | This is a representation of the 0 by 0 empty matrix which does not occupy memory |
  Permutation | Size is n |
  PolynomialBB | Represent the matrix P(A) where A is a blackbox and P a polynomial |
  PolynomialBBOwner | Represent the matrix P(A) where A is a blackbox and P a polynomial |
  ZOQuad | A class of striped or block-decomposed zero-one matrices |
  ScalarMatrix | Blackbox for aI |
  SparseMatrix | Vector of sparse rows |
  SparseMatrixFactory | 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 | Transpose matrix without copying |
  Submatrix | 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< BlasMatrix< _Field >, VectorCategories::DenseVectorTag > | Specialization for BlasMatrix |
  SubmatrixOwner< Blackbox, VectorCategories::DenseVectorTag > | Specialization for dense vectors |
  Sum | Blackbox of a matrix sum without copying |
  SumOwner | Blackbox of a matrix sum without copying |
  Toeplitz | 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 | Transpose matrix without copying |
  TransposeOwner | Transpose matrix without copying |
  TriplesBB | Wrapper for NAG Sparse Matrix format |
  ZeroOne | Time and space efficient representation of sparse {0,1}-matrices |
   IndexIterator | IndexIterator |
   Iterator | Raw iterator |
  ZeroOne< GF2 > | Time and space efficient representation of sparse matrices over GF2 |
   IndexIterator | IndexIterator |
   Iterator | Raw iterator |
  ElementAbstract | Abstract element base class, a technicality |
  ElementArchetype | Field and Ring element interface specification and archetypical instance class |
  ElementEnvelope | Adaptor from archetypical interface to abstract interface, a technicality |
  GMPRationalElement | Elements of GMP_Rationals |
  FieldAbstract | Field base class |
  FieldArchetype | Field specification and archetypical instance |
  BlockRing | Elements are wrapped BlasMatrix objects |
   Element | Default constructable wrapper for BlasMatrix |
  FieldEnvelope | Derived class used to implement the field archetypeHelps to minimize code bloat |
  FieldInterface | This field base class exists solely to aid documentation organization |
  ClassifyRing | Default ring category |
  FieldTraits | FieldTrait |
  GivaroExtension | 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 |
  Hom< BaseField, GivaroExtension< BaseField > > | NO DOC |
  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 |
  GivaroField | 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 .. |
  GivaroGfq | Wrapper of Givaro's GFqDom<int32_t> class |
  GivaroMontg | Wrapper of Givaro's Givaro::Montgomery< Givaro::Std32> |
  GivaroZpz | Wrapper of Givaro's ZpzDom |
  NoHomError | Error object for attempt to establish a Hom that cannot exist |
  Hom | 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 |
  LidiaGfq | Defines the Galois Field GF(pk) |
  Local2_32 | Fast arithmetic mod 2^32, including gcd |
  ModularBalanced< double > | Centered representation of  |
  FieldAXPY< ModularBalanced< double > > | Specialization of FieldAXPY |
  DotProductDomain< ModularBalanced< double > > | Specialization of DotProductDomain |
  Modular< int8_t > | Specialization of Modular to signed 8 bit element type with efficient dot product |
  Modular< double > | Standard representation of  |
  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< int16_t > | Specialization of Modular to short element type with efficient dot product |
  Modular< uint8_t > | Allows compact storage when the modulus is less than 2^8 |
  FieldAXPY< Modular< uint8_t > > | Specialization of FieldAXPY for uint8_t modular field |
  DotProductDomain< Modular< uint8_t > > | Specialization of DotProductDomain for unsigned short modular field |
  MVProductDomain< Modular< uint8_t > > | Specialization of MVProductDomain for uint8_t modular field |
  Modular< uint16_t > | Specialization of class Modular for uint16_t element type |
  FieldAXPY< Modular< uint16_t > > | Specialization of FieldAXPY for uint16_t modular field |
  DotProductDomain< Modular< uint16_t > > | Specialization of DotProductDomain for unsigned short modular field |
  MVProductDomain< Modular< uint16_t > > | Specialization of MVProductDomain for uint16_t modular field |
  Modular< uint32_t > | Specialization of class Modular for uint32_t element type |
  FieldAXPY< Modular< uint32_t > > | Specialization of FieldAXPY for unsigned short modular field |
  DotProductDomain< Modular< uint32_t > > | Specialization of DotProductDomain for uint32_t modular field |
  MVProductDomain< Modular< uint32_t > > | Specialization of MVProductDomain for uint32_t modular field |
  Modular | Prime fields of positive characteristic implemented directly in LinBox |
  FieldAXPY< Modular< _Element > > | Specialization of FieldAXPY for parameterized modular field |
  NTL_zz_p | Long ints modulo a positive integer |
  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 | Integer ring |
  NTL_ZZ_p | Wrapper of zz_p from NTL |
  UnparametricRandIter< NTL::ZZ_p > | Constructor for random field element generator |
  NTL_ZZ_pE | Wrapper of ZZ_pE from NTL Define a parameterized class to handle easily 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) |
  ParamFuzzy | Abstract parameterized field of "fuzzy" doubles |
  PID_double | NO DOC |
  PID_integer | Domain for integer operations |
  NTL_PID_zz_p | Extend Wrapper of zz_p from NTL |
  PIR_ntl_ZZ_p | Extend Wrapper of ZZ_p from NTL |
  Rebind | Used in support of Hom, MatrixHom |
  FieldAXPY< UnparametricField< integer > > | NO DOc |
  MatrixArchetype | Directly-represented matrix archetype |
  BlasMatrix< MultiModDouble > | No Doc |
  BlasMatrix | Dense matrix representation |
   IndexedIterator | Indexed Iterator |
  BlasSubmatrix | Dense Submatrix representation |
   ConstIndexedIterator | Raw Indexed Iterator (const version) |
   ConstIterator | Raw Iterators (const version) |
   IndexedIterator | Raw Indexed Iterator |
   Iterator | Raw Iterators |
  TriangularBlasMatrix | Triangular BLAS matrix |
  indexDomain | Class used for permuting indices |
  TransposedBlasMatrix | TransposedBlasMatrix |
  TransposedBlasMatrix< TransposedBlasMatrix< Matrix > > | TransposedBlasMatrix |
  DenseRowsMatrix | Dense row-wise matrix container |
  LQUPMatrix | LQUP factorisation |
  MatrixDomain< GF2 > | Specialization of MatrixDomain for GF2 |
  MatrixCategories | For specializing matrix arithmetic |
  MVProductDomain | Helper class to allow specializations of certain matrix-vector products |
  MatrixDomain | Class of matrix arithmetic functions |
  BlasPermutation | Lapack-style permutation |
  MatrixPermutation | Permutation classique |
  RankBuilder | Random method for constructing rank |
  RandomDenseMatrix | Random Dense Matrix builder |
  InvalidMatrixInput | Exception class for invalid matrix input |
  FieldIO | Dummy field for conceptually unclear io |
  SparseMatrixBase | Sparse matrix container This class acts as a generic row-wise container for sparse matrices |
  TransposeMatrix | Matrix transpose |
  RandIterAbstract | Random field element generator |
  RandIterArchetype | Random field element generator archetype |
  RandIterEnvelope | Random field base element generator |
  GmpRandomPrime | Generating random prime integers, using the gmp library |
  ModularBalancedRandIter | Random field base element generator |
  ModularCrookedRandIter | Random field base element generator |
  ModularRandIter | Random field base element generator |
  NonzeroRandIter | Random iterator for nonzero random numbers |
  RandomIntegerIterator | Random Prime Generator |
  RandomIntegerIter | Random Integer Iterator |
  RandomPrimeIterator | Random Prime Generator |
  RandomPrimeIter | Random Prime Iterator |
  UnparametricRandIter | Unparameterized random field element generator template |
  RingAbstract | Abstract ring base class |
  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 |
  RingEnvelope | Implement the ring archetype to minimize code bloat |
  GivPolynomialRing | Polynomials |
  PowerOfTwoModular | Ring of elements modulo some power of two |
   RandIter | Random iterator generator type |
  RingInterface | This ring base class exists solely to aid documentation organization |
  HybridSpecifier | HybridSpecifier |
  BlackboxSpecifier | BlackboxSpecifier |
  EliminationSpecifier | EliminationSpecifier |
  CRASpecifier | CRASpecifier |
  IMLTraits | IML wrapper |
  Method | Method specifiers for controlling algorithm choice |
  CRATraits | Solve using CRA (iterations uses SolveMethod) |
  SolverTraits | Solver traits |
  SolveFailed | Exception thrown when the computed solution vector is not a true solution to the system, but none of the problems cited below exist |
  InconsistentSystem | Exception thrown when the system to be solved is inconsistent |
  BooleanSwitch | Boolean switch object |
  BooleanSwitchFactory | Boolean switch factory |
  CekstvSwitch | Butterfly switch object from preconditioner paper |
  CekstvSwitchFactory | Cekstv switch factory |
  Commentator | Give information to user during runtime |
  PreconditionFailed | A precondition failed |
  Exception | This is the exception class in LinBox |
  algoException | Algorithmic exception |
  NotImplementedYetException | Not implemented yet |
  IrrecuperableException | Something bad an unexpected happened |
  BadInputException | The input is not as expected |
  LinboxError | Base class for execption handling in LinBox |
  FieldAXPY | FieldAXPY object |
  MatrixStreamReader | An abstract base class to represent readers for specific formats |
  MatrixStream | MatrixStream |
  PrimeStream | Prime number stream |
  BitVector | Binary constant defined both for 32 and 64 bits |
  ReverseVector | Reverse vector class This class wraps an existing vector type and reverses its direction |
  Sparse_Vector | Vector< Pair<T,I> > and actualsize |
  VectorStream | Vector factory |
  ConstantVectorStream | Constant vector factory |
  RandomDenseStream | Random dense vector stream |
  RandomDenseStream< Field, _Vector, RandIter, VectorCategories::DenseVectorTag > | Specialization of random dense stream for dense vectors |
  RandomSparseStream | Random sparse vector stream |
  RandomSparseStream< Field, _Vector, RandIter, VectorCategories::DenseVectorTag > | Specialization of RandomSparseStream for dense vectors |
  RandomSparseStream< Field, _Vector, RandIter, VectorCategories::SparseSequenceVectorTag > | Specialization of RandomSparseStream for sparse sequence 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 |
  StandardBasisStream | Stream for  |
  StandardBasisStream< Field, _Vector, VectorCategories::DenseVectorTag > | Specialization of standard basis stream for dense vectors |
  StandardBasisStream< Field, _Vector, VectorCategories::SparseSequenceVectorTag > | Specialization of standard basis stream for sparse sequence 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 |
  Subiterator | Subvector iterator class provides striding iterators |
  Subvector | Dense subvectorThis class provides a statically sized subvector of a random access container (such as std::vector, deque) |
  VectorCategories | List of vector categories |
   DenseVectorTag | Dense vector (GF2 and general) |
   DenseZeroOneVectorTag | Sparse vectors (general) |
   GenericVectorTag | Generic vector (no assumption is made) |
   SparseAssociativeVectorTag | Sparse vectors (general) |
   SparseParallelVectorTag | Sparse vectors (general) |
   SparseSequenceVectorTag | Sparse vectors (general) |
   SparseVectorTag | Sparse vectors (general) |
   SparseZeroOneVectorTag | Sparse GF2 vectors |
  VectorTraits | Vector traits template structure |
  RawVector | Canonical vector types |
  Vector | Vector ?? |
  Rebind< std::vector< T >, U > | Rebind |
  PlotStyle | Represents a table of values to plot |
   Plot | What style of graphic : histogram ? graph ? |
   Term | What format the plot should be in? |
  PlotData | The raw data to plot |
  PlotGraph | The graph |
 subtests | Tests of algebraic properties of fields |
 foobar | Test 1: Invariant factors of random dense matrices |
 Pair | Pair of I and T : struct { column index, value } |