N field_subtests Tests of algebraic properties of rings and fields
► N LinBox Namespace in which all linbox code resides
N Exceptions Exception class for invalid matrix input
N IndexedTags Limited doc so far
► N IteratorCategories Information about the type of Prime Iterator
C DeterministicTag Iterator following a deterministic sequence of primes (from the largest one, in decreasing order
C HeuristicTag Iterator sampling randomly (no distribution guaranteed whatsoever) from all primes of given bitsize
C UniformTag Iterator sampling uniformly from all primes of given bitsize
N MatrixHom Limited doc so far. Used in DixonSolver
► N Protected This is the namespace all LinBox internal code is in
C SparseMatrixGeneric Sparse matrix container This class acts as a generic row-wise container for sparse matrices
N Rank Rank of the system, if known
► N RingCategories Some basic information about each field or ring
C GaloisTag Galois Field GF(p^e)
C GenericTag Generic ring
C IntegerTag If it is isomorphic to Z
C ModularTag If it is isomorphic to Z/mZ, for some m or its extensions
C RationalTag If it is isomorphic to Q
N Shape Flags decribing the shape of the matrix
N SparseFileFormat Sparse matrix format (file storage)
► N SparseMatrixFormat Sparse matrix format (memory storage)
C BCSR Block CSR
C COO Cordinate
C COO1 Implicit value COO (with only ones, or mones, or..)
C CSR Compressed row
C CSR1 Implicit value CSR (with only ones, or mones, or..)
C DIA Diagonal
C ELL Ellpack
C ELL_R Ellpack fixed row
C HYB Hybrid
C LIL Vector of pairs
C SMM Sparse Map of Maps
C SparseMap Pair of vector/list (Pair of Containers)
C SparsePar Vector/list of pairs (Container of Maps)
C SparseSeq Vector/list of pairs (Container of Pairs)
C TPL Vector of triples
C TPL_omp Triplesbb for openmp
N Tag Structure for tags
N VectorWrapper Limited doc so far
C algoException Algorithmic exception
C AlgorithmMetaData Algorithm metadata;
C BadInputException The input is not as expected
C BenchmarkMetaData Benchmark metadata;
C BitVector Binary constant defined both for 32 and 64 bits
C BlackboxArchetype Showing the member functions provided by all blackbox matrix classes
C BlackboxBlockContainerBase A base class for BlackboxBlockContainer
C BlackboxBlockContainerRecord No doc
C BlackboxContainer Limited doc so far
C BlackboxContainerBase A base class for BlackboxContainer
C BlackboxContainerSymmetric See base class for doc
C BlackboxContainerSymmetrize Symmetrizing iterator (for rank computations)
C BlackboxFactory A tool for computations with integer and rational matrices
► C BlasMatrix Dense matrix representation
C rebind Rebind operator
C BlasMatrix< MultiModDouble > No Doc
C BlasMatrixDomain Interface for all functionnalities provided for BlasMatrix
C BlasMatrixDomainAddin C += A
C BlasMatrixDomainSubin C -= A
C BlasPermutation Lapack-style permutation
C BlockBB Converts a black box into a block black box
C BlockCompose Blackbox of a product: , i.e
C BlockCoppersmithDomain Compute the linear generator of a sequence of matrices
C BlockHankelLiftingContainer Block Hankel LiftingContianer
C BlockLanczosSolver Block Lanczos iteration
C BlockMasseyDomain Compute the linear generator of a sequence of matrices
C BlockWiedemannLiftingContainer Block Wiedemann LiftingContianer
C BooleanSwitch Boolean switch object
C Butterfly Switching Network based BlackBox Matrix
C CekstvSwitch The default butterfly switch object
C ChineseRemainder No doc
► C ChineseRemainderSequential No doc
C PrimeSampler Helper class to sample unique primes
C PrimeSampler< PrimeIterator, true > Helper class to sample unique primes
C ClassifyRing Default ring category
C Commentator Give information to user during runtime
C Companion Companion matrix of a monic polynomial
C Compose Blackbox of a product: , i.e
C Compose< _Blackbox, _Blackbox > Specialization for _Blackbox1 = _Blackbox2
C ComposeOwner Blackbox of a product: , i.e
C ComposeTraits Used in ..., for example
C ComposeTraits< BlasMatrix< Field, Rep > > Used in smith-binary, for example
C ConstantVectorStream Constant vector factory
C ContainerCategories Used to separate BLAS2 and BLAS3 operations
C ContainerTraits Trait for the Category
C CRABuilderEarlyMultip NO DOC
C CRABuilderEarlySingle Heuristic Chinese Remaindering with early termination
C CRABuilderFullMultip Chinese remaindering of a vector of elements without early termination
C CRABuilderFullMultipFixed Chinese Remaindering Algorithm for multiple residues
C CRABuilderFullMultipMatrix NO DOC
C CRABuilderFullSingle Chinese Remaindering with full precision and no chance of failure
C CRABuilderProbSingle Chinese Remaindering with guaranteed probability bound and early termination
C CRABuilderSingleBase Abstract base class for CRA builders
C CRAResidue Type information for the residue in a CRA iteration
C CRAResidue< Integer, Function > Type information for the residue in a CRA iteration
C CRAResidue< std::vector< Integer >, Function > Type information for the residue in a CRA iteration
C CSF Space efficient representation of sparse matrices
C DataSeries This structure holds a bunch of timings
C DenseContainer Limited doc so far
C DenseMat To be used in standard matrix domain
C DensePolynomial Dense Polynomial representation using Givaro
C Diagonal Random diagonal matrices are used heavily as preconditioners
C Diagonal< _Field, VectorCategories::DenseVectorTag > Specialization of Diagonal for application to dense vectors
C Diagonal< _Field, VectorCategories::SparseAssociativeVectorTag > Specialization of Diagonal for application to sparse associative vectors
C Diagonal< _Field, VectorCategories::SparseSequenceVectorTag > Specialization of Diagonal for application to sparse sequence vectors
C Dif Blackbox of a difference: C := A - B
, i.e Cx = Ax - Bx
C DiophantineSolver DiophantineSolver<QSolver> creates a diophantine solver using a QSolver to generate rational solutions
C DirectSum If C = DirectSum(A, B) and y = xA and z = wB, then (y,z) = (x,w)C
C DixonLiftingContainer Dixon Lifting Container
C DixonSolver Interface for the different specialization of p-adic lifting based solvers
C DixonSolver< Ring, Field, RandomPrime, Method::BlockHankel > Block Hankel
C DixonSolver< Ring, Field, RandomPrime, Method::BlockWiedemann > Partial specialization of p-adic based solver with block Wiedemann algorithm
C DixonSolver< Ring, Field, RandomPrime, Method::DenseElimination > Partial specialization of p-adic based solver with Dixon algorithm
C DixonSolver< Ring, Field, RandomPrime, Method::SparseElimination > Sparse LU
C DixonSolver< Ring, Field, RandomPrime, Method::SymbolicNumericNorm > Solver using a hybrid Numeric/Symbolic computation
C DixonSolver< Ring, Field, RandomPrime, Method::Wiedemann > Partial specialization of p-adic based solver with Wiedemann algorithm
C DotProductDomain< Givaro::Modular< uint8_t, Compute_t > > Specialization of DotProductDomain for unsigned short modular field
C DotProductDomain< Givaro::ModularBalanced< double > > Specialization of DotProductDomain
C ElementAbstract Abstract element base class, a technicality
C ElementArchetype Field and Ring element interface specification and archetypical instance class
C ElementEnvelope Adaptor from archetypical interface to abstract interface, a technicality
C Eliminator Elimination system
C EnvironmentMetaData Environment metadata;
C Exception This is the exception class in LinBox
C FieldAbstract Field base class
C FieldArchetype Field specification and archetypical instance
C FieldAXPY FieldAXPY object
C FieldAXPY< Givaro::Modular< uint8_t, Compute_t > > Specialization of FieldAXPY for uint8_t modular field
C FieldAXPY< Givaro::ModularBalanced< double > > Specialization of FieldAXPY
C FieldDocumentation This field base class exists solely to aid documentation organization
C FieldEnvelope Derived class used to implement the field archetype
C FieldMetaData Field metadata
C FieldTraits FieldTrait
C FixedPrimeIterator Adaptor class to make a single prime number behave like a PrimeIterator
C GaussDomain Repository of functions for rank by elimination on sparse matrices
C GeneratorMetaData Generator metadata;
C GenericRandIter Random field base element generator
C GetEntryCategory GetEntryCategory is specialized for BB classes that offer a local getEntry
C GivaroRnsFixedCRA NO DOC..
C GmpRandomPrime Generating random prime integers, using the gmp library
C GMPRationalElement Elements of GMP_Rationals
C Hilbert Example of a blackbox that is space efficient, though not time efficient
C Hilbert_JIT_Entry The object needed to build a Hilbert matrix as a JIT matrix
C Hom Map element of source ring(field) to target ring
C InconsistentSystem Exception thrown when the system to be solved is inconsistent
C indexDomain Class used for permuting indices
C IndexedCategory Trait to show whether or not the BB class has a Indexed iterator
C IndexedCategory< BlasMatrix< Field, _Rep > >
C Inverse A Blackbox for the inverse
C InvertTextbookDomain Assumes that Field is a field, not a ring
C IrrecuperableException Something bad an unexpected happened
C JIT_Matrix Example of a blackbox that is space efficient, though not time efficient
C LABlockLanczosSolver Biorthogonalising block Lanczos iteration
C LanczosSolver Solve a linear system using the conjugate Lanczos iteration
C LargeDouble NO DOC
C LastInvariantFactor This is used in a Smith Form algorithm
C latticeMethod NTL methods
C LinboxError Base class for execption handling in LinBox
C Local2_32 Fast arithmetic mod 2^32, including gcd
C MaskedPrimeIterator Masked Prime Iterator
C MasseyDomain Berlekamp/Massey algorithm
C MatrixArchetype Directly-represented matrix archetype
C MatrixBlackbox Matrix black box
C MatrixCategories For specializing matrix arithmetic
C MatrixContainerTrait NODOC
C MatrixDomain Class of matrix arithmetic functions
C MatrixDomain< GF2 > Specialization of MatrixDomain for GF2
C MatrixEltPointer Dense Submatrix representation
C MatrixHomTrait Try to map a blackbox over a homorphic ring The most suitable type
C MatrixMetaData Matrix metadata
C MatrixPermutation Permutation classique
C MatrixStream MatrixStream
C MatrixStreamReader An abstract base class to represent readers for specific formats
C MatrixTraits NO DOC
C MetaData This is the general metadata class
C Method Define which method to use when working on a system
C MethodBase Holds everything a method needs to know about the problem
C MGBlockLanczosSolver Block Lanczos iteration
C ModularCrookedRandIter Random field base element generator
C MoorePenrose Generalized inverse of a blackbox
C MVProductDomain Helper class to allow specializations of certain matrix-vector products
C MVProductDomain< Givaro::Modular< uint8_t, Compute_t > > Specialization of MVProductDomain for uint8_t modular field
C NoHomError Error object for attempt to establish a Hom that cannot exist
C NotImplementedYetException Not implemented yet
C NTL_PID_zz_p Extend Wrapper of zz_p from NTL
C NTL_ZZ Integer ring
C NTL_zz_p Long ints modulo a positive integer
C NTL_ZZ_p Wrapper of zz_p from NTL
C NTL_ZZ_pE Wrapper of ZZ_pE from NTL Define a parameterized class to handle easily Givaro::ZRing<NTL::ZZ_pE> field
C NTL_zz_pE Zz_pE Define a parameterized class to easily handle Givaro::ZRing<NTL::zz_pE> field
C NTL_zz_pE_Initialiser Use ZZ_pEBak mechanism too ?
C NTL_zz_pEX Ring (in fact, a unique factorization domain) of polynomial with coefficients in class NTL_zz_p (integers mod a wordsize prime)
C NTL_zz_pX Ring (in fact, a unique factorization domain) of polynomial with coefficients in class NTL_zz_p (integers mod a wordsize prime)
C NTL_ZZ_pX Ring (in fact, a unique factorization domain) of polynomial with coefficients in class NTL_ZZ_p (integers mod a wordsize prime)
C NullMatrix This is a representation of the 0 by 0 empty matrix which does not occupy memory
C OneInvariantFactor Limited doc so far
C OpenCLEnviron Container for all pertenant information needed to use an OpenCL device, compile kernels for the device, track resource usage, and gain exclusive access to the device
C OpenCLMatrixDomain Interface for all functionnalities provided for BlasMatrix using GPUs
C ParamFuzzy Abstract parameterized field of "fuzzy" doubles
C PIR_ntl_ZZ_p Extend Wrapper of ZZ_p from NTL
C PlainSubmatrix To be used in reference matrix domain (PlainDomain)
C PlotData The raw data to plot
C PlotGraph The graph (2D)
► C PlotStyle Represents a table of values to plot (2D)
C Plot What style of graphic : histogram ? graph ?
C Term What format the plot should be in?
C PLUQMatrix PLUQ factorisation
C PolynomialBB Represent the matrix P(A) where A is a blackbox and P a polynomial
C PolynomialBBOwner Represent the matrix P(A) where A is a blackbox and P a polynomial
C PolynomialRing Polynomials
C PowerGaussDomain Repository of functions for rank modulo a prime power by elimination on sparse matrices
C PowerGaussDomainPowerOfTwo Repository of functions for rank modulo a prime power by elimination on sparse matrices
C PreconditionFailed A precondition failed
C PrimeIterator Prime Iterator
C PrimeSequence Adaptor class to make a fixed-length sequence behave like a PrimeIterator
C PrimeStream Prime number stream
C RandIterAbstract Random field element generator
C RandIterArchetype Random field element generator archetype
C RandIterEnvelope Random field base element generator
C RandomDenseMatrix Random Dense Matrix builder
C RankBuilder Random method for constructing rank
C RationalChineseRemainder Chinese remainder of rationals
C RationalChineseRemainderVarPrec Chinese remainder of vector of rationals
C RationalReconstruction Limited doc so far
C RawVector Canonical vector types
C Rebind Used in support of Hom , MatrixHom
C Rebind< std::vector< T >, U > Rebind
C ReverseVector Reverse vector class This class wraps an existing vector type and reverses its direction
C RingAbstract Abstract ring base class
C RingArchetype Specification and archetypic instance for the ring interface
C RingEnvelope Implement the ring archetype to minimize code bloat
C RingInterface This ring base class exists solely to aid documentation organization
C RNS RNS
C ScalarMatrix Blackbox for aI
C SemiDIteration CRA iteration to get a diagonal with the same signature
C showProgression Show progression on the terminal (helper)
C SigmaBasis Implementation of -basis (minimal basis)
C Sliced The Sliced Matrix class _Domain must be a GF(3) rep, BaseT must be an unsigned int type
C SlicedPolynomialMatrixAddin C += A
C SlicedPolynomialMatrixSubin C -= A
C SlicedPolynomialVectorAddin C += A
C SlicedPolynomialVectorSubin C -= A
C SmithFormBinary Compute Smith form
C SmithFormIliopoulos This is Iliopoulos' algorithm to diagonalize
C SmithFormLocal Smith normal form (invariant factors) of a matrix over a local ring
C Sparse_Vector Vector < Pair<T,I> > and actualsize
C SparseLULiftingContainer SparseLULiftingContainer
C SparseMatrix< _Field, SparseMatrixFormat::COO > Sparse matrix, Coordinate storage
C SparseMatrix< _Field, SparseMatrixFormat::COO::implicit > Sparse matrix, Coordinate storage
► C SparseMatrix< _Field, SparseMatrixFormat::CSR > Sparse matrix, Coordinate storage
C IndexedIterator Forward iterator
C SparseMatrix< _Field, SparseMatrixFormat::ELL > Sparse matrix, Coordinate storage
C SparseMatrix< _Field, SparseMatrixFormat::ELL_R > Sparse matrix, Coordinate storage
C SparseMatrix< _Field, SparseMatrixFormat::HYB > Sparse matrix, Coordinate storage
C SparseMatrix< Field_, SparseMatrixFormat::TPL > Sparse Matrix in Triples storage
C SparseMatrix< Field_, SparseMatrixFormat::TPL_omp > Sparse matrix representation which stores nonzero entries by i,j,value triples
C SparseMatrixReadHelper Read helper
C SparseMatrixWriteHelper Write helper
C Squarize Transpose matrix without copying
C StorageMetaData Storage metadata;
C Subiterator Subvector iterator class provides striding iterators
C Submatrix Leading principal minor of existing matrix without copying
C SubmatrixAdapter Generic submatrix view adapter used internally in the OpenCLMatrixDomain
C SubmatrixOwner< Blackbox, VectorCategories::DenseVectorTag > Specialization for dense vectors
C Subvector Dense subvector
C Sum Blackbox of a matrix sum without copying
C SumOwner Blackbox of a matrix sum without copying
C Sylvester This is a representation of the Sylvester matrix of two polynomials
C TernaryLattice NO DOC
C TimeWatcher Helper
C Toeplitz This is the blackbox representation of a Toeplitz matrix
C Toeplitz< typename _PRing::CoeffField, _PRing > Specialization for when the field of matrix elements is the same as the coefficient field of the polynomial field
C TraceCategory Trait to show whether or not the BB class has a local trace function
C Transpose Transpose matrix without copying
C TransposedBlasMatrix TransposedBlasMatrix
C TransposeMatrix Matrix transpose
C TransposeOwner Transpose matrix without copying
C TriangularBlasMatrix Triangular BLAS matrix
C UniqueSamplingTrait Whether a prime generator generates a sequence with non repeating numbers
C UnparametricRandIter< NTL::ZZ_p > Constructor for random field element generator
C Vector Vector ??
► C VectorCategories List of vector categories
C DenseVectorTag Dense vector (GF2 and general)
C DenseZeroOneVectorTag Sparse vectors (general)
C GenericVectorTag Generic vector (no assumption is made)
C SparseAssociativeVectorTag Sparse vectors (general)
C SparseParallelVectorTag Sparse vectors (general)
C SparseSequenceVectorTag Sparse vectors (general)
C SparseVectorTag Sparse vectors (general)
C SparseZeroOneVectorTag Sparse GF2 vectors
C VectorFraction VectorFraction<Domain> is a vector of rational elements with common reduced denominator
C VectorStream Vector factory
C VectorTraits Vector traits template structure
C WiedemannLiftingContainer Wiedemann LiftingContianer
C WiedemannSolver Linear system solvers based on Wiedemann's method
► C ZeroOne Time and space efficient representation of sparse {0,1}-matrices
C IndexIterator IndexIterator
C Iterator Raw iterator
► C ZeroOne< GF2 > Time and space efficient representation of sparse matrices over GF2
C IndexedIterator IndexedIterator
C Iterator Raw iterator
C ZOQuad A class of striped or block-decomposed zero-one matrices
N std STL namespace