Data Structures

Here are the data structures with brief descriptions:
adapt_stepAdaptive stepper [abstract base]
akima_interpAkima spline interpolation (GSL)
akima_peri_interpAkima spline interpolation with periodic boundary conditions (GSL)
anneal_mtMultidimensional minimization by simulated annealing (Boost multi-threaded version)
array_2d_allocA simple class to provide an allocate() function for 2-dimensional arrays
array_2d_colColumn of a 2d array
array_2d_rowRow of a 2d array
array_allocA simple class to provide an allocate() function for arrays
array_const_reverseA simple class which reverses the order of an array
array_const_subvectorA simple subvector class for a const array (without error checking)
array_const_subvector_reverseReverse a subvector of a const array
array_interpA specialization of o2scl_interp for C-style double arrays
array_interp_vecA specialization of o2scl_interp_vec for C-style arrays
array_reverseA simple class which reverses the order of an array
array_subvectorA simple subvector class for an array (without error checking)
array_subvector_reverseReverse a subvector of an array
base_interpBase low-level interpolation class [abstract base]
base_interp_mgrA base interpolation object manager [abstract base]
base_iocSetup I/O objects for base library classes
bin_sizeDetermine bin size (CERNLIB)
binary_in_fileBinary input file
binary_out_fileBinary output file
bool_io_typeI/O object for bool variables
cern_adaptAdaptive integration (CERNLIB)
cern_cauchyCauchy principal value integration (CERNLIB)
cern_cubic_real_coeffSolve a cubic with real coefficients and complex roots (CERNLIB)
cern_derivNumerical differentiation routine (CERNLIB)
cern_gaussGaussian quadrature (CERNLIB)
cern_gauss565,6-point Gaussian quadrature (CERNLIB)
cern_minimizeOne-dimensional minimization (CERNLIB)
cern_mrootMulti-dimensional mroot-finding routine (CERNLIB)
cern_mroot_rootOne-dimensional version of cern_mroot
cern_quartic_real_coeffSolve a quartic with real coefficients and complex roots (CERNLIB)
cern_rootOne-dimensional root-finding routine (CERNLIB)
char_io_typeI/O object for char variables
cinputClass to control object input
cliConfigurable command-line interface
cli_readlineAn extension to cli which uses readline
cmd_line_argA command-line argument for cli
collectionCollection of objects
collection::iteratorAn iterator for stepping through a collection
collection::type_iteratorAn iterator for stepping through the entries in a collection of a particular type
collection_entry
columnifyCreate nicely formatted columns from a table of strings
comm_option_functBase for cli command function
comm_option_mfptrMember function pointer for cli command function
comm_option_sCommand for interactive mode in cli
comp_gen_inteNaive generalized multi-dimensional integration
composite_inteNaive multi-dimensional integration over a hypercube
contourCalculate contour lines from a two-dimensional data set
contour_lineA contour line
convert_unitsConvert units
convert_units::unit_tThe type for caching unit conversions
convert_units_gnuConvert units using a system call to GNU units
coutputClass to control object output
coutput::ltptrOrder the pointers by numeric value
cspline_interpCubic spline interpolation (GSL)
cspline_peri_interpCubic spline interpolation with periodic boundary conditions (GSL)
cubic_complexSolve a cubic polynomial with complex coefficients and complex roots [abstract base]
cubic_realSolve a cubic polynomial with real coefficients and real roots [abstract base]
cubic_real_coeffSolve a cubic polynomial with real coefficients and complex roots [abstract base]
cubic_std_complexSolve a cubic with complex coefficients and complex roots
def_interp_mgrA base interpolation object manager template
derivNumerical differentiation base [abstract base]
deriv::dparsA structure for passing the function to second and third derivatives
deriv_iocSetup I/O objects for numerical differentiation classes
double_io_typeI/O object for double variables
edge_crossingsEdges for the contour class
eqi_derivDerivatives for equally-spaced abscissas
err_baseClass defining an error handler [abstract base]
err_classThe error handler
exact_jacobianA direct calculation of the jacobian using a deriv object
exact_jacobian::ej_parmsParameter structure for passing information
file_detectRead a (possibly compressed) file and automatically detect the file format
fit_baseNon-linear least-squares fitting [abstract base]
fit_fix_parsMultidimensional fitting fixing some parameters and varying others
fit_functFitting function [abstract base]
fit_funct_cmfptrConst member function pointer fitting function
fit_funct_fptrFunction pointer fitting function
fit_funct_mfptrMember function pointer fitting function
fit_vfunctFitting function with arrays [abstract base]
fit_vfunct_cmfptrConst member function pointer fitting function with arrays
fit_vfunct_fptrFunction pointer fitting function with arrays
fit_vfunct_mfptrMember function pointer fitting function with arrays
format_floatFormat a floating point number into a Latex or HTML string
functOne-dimensional function [abstract base]
funct_cmfptrConst member function pointer to a one-dimensional function
funct_cmfptr_noerrConst member function pointer to a one-dimensional function returning the function value
funct_cmfptr_noparConst member function pointer to a one-dimensional function with no parameters
funct_fptrFunction pointer to a function
funct_fptr_noerrFunction pointer to a function returning the function value
funct_fptr_noparFunction pointer to a function with no parameters
funct_mfptrMember function pointer to a one-dimensional function
funct_mfptr_noerrMember function pointer to a one-dimensional function returning the function value
funct_mfptr_noparMember function pointer to a one-dimensional function with no parameters
gaussian_2dGenerate two random numbers from a normal distribution
gen_inteGeneralized multi-dimensional integration [abstract base]
gen_test_numberGenerate number sequence for testing
grad_functGradient function [abstract base]
grad_funct_cmfptrConst member function pointer to a gradient
grad_funct_fptrFunction pointer to a gradient
grad_funct_mfptrMember function pointer to a gradient
grad_vfunctBase class for a gradient function using arrays [abstract base]
grad_vfunct_cmfptrConst member function pointer to a gradient
grad_vfunct_fptrFunction pointer to a gradient
grad_vfunct_mfptrMember function pointer to a gradient
gradientClass for automatically computing gradients [abstract base]
gradient_arrayBase class for automatically computing gradients with arrays [abstract base]
gsl_annealMultidimensional minimization by simulated annealing (GSL)
gsl_astepAdaptive ODE stepper (GSL)
gsl_bsimpBulirsch-Stoer implicit ODE stepper (GSL)
gsl_chebappChebyshev approximation (GSL)
gsl_cubic_real_coeffSolve a cubic with real coefficients and complex roots (GSL)
gsl_derivNumerical differentiation (GSL)
gsl_fftReal mixed-radix fast Fourier transform
gsl_fitNon-linear least-squares fitting class (GSL)
gsl_fit::func_parA structure for passing to the functions func(), dfunc(), and fdfunc()
gsl_inteGSL integration base
gsl_inte_chebChebyshev integration base class (GSL)
gsl_inte_kronrodBasic Gauss-Kronrod integration class (GSL)
gsl_inte_qagAdaptive integration a function with finite limits of integration (GSL)
gsl_inte_qagiIntegrate a function from $ -\infty $ to $ \infty $ (GSL)
gsl_inte_qagilIntegrate a function from $ -\infty $ to $ \mathrm{b} $ (GSL)
gsl_inte_qagiuIntegrate a function from $ a $ to $ \infty $ (GSL)
gsl_inte_qagsIntegrate a function with a singularity (GSL)
gsl_inte_qawcAdaptive Cauchy principal value integration (GSL)
gsl_inte_qawf_cosAdaptive integration a function with finite limits of integration (GSL)
gsl_inte_qawf_sinAdaptive integration for oscillatory integrals (GSL)
gsl_inte_qawo_cosAdaptive integration a function with finite limits of integration (GSL)
gsl_inte_qawo_sinAdaptive integration for oscillatory integrals (GSL)
gsl_inte_qawsQAWS integration (GSL)
gsl_inte_qngNon-adaptive integration from a to b (GSL)
gsl_inte_singularBase class for integrating a function with a singularity (GSL)
gsl_inte_singular::extrapolation_tableA structure for extrapolation for gsl_inte_qags
gsl_inte_tableBase routines for the GSL adaptive integration classes
gsl_inte_transformIntegrate a function with a singularity (GSL) [abstract base]
gsl_min_brentOne-dimensional minimization using Brent's method (GSL)
gsl_miserMultidimensional integration using Miser Monte Carlo (GSL)
gsl_mmin_baseBase minimization routines for gsl_mmin_conf and gsl_mmin_conp
gsl_mmin_bfgs2Multidimensional minimization by the BFGS algorithm (GSL)
gsl_mmin_bfgs2_arrayAn array version of gsl_mmin_bfgs2
gsl_mmin_confMultidimensional minimization by the Fletcher-Reeves conjugate gradient algorithm (GSL)
gsl_mmin_conf_arrayAn array version of gsl_mmin_conf
gsl_mmin_conpMultidimensional minimization by the Polak-Ribiere conjugate gradient algorithm (GSL)
gsl_mmin_conp_arrayAn array version of gsl_mmin_conp
gsl_mmin_linminThe line minimizer for gsl_mmin_bfgs2
gsl_mmin_simpMultidimensional minimization by the Simplex method (GSL)
gsl_mmin_simp2Multidimensional minimization by the Simplex method (v2) (GSL)
gsl_mmin_wrap_baseVirtual base for the gsl_mmin_bfgs2 wrapper
gsl_mmin_wrapperWrapper class for the gsl_mmin_bfgs2 minimizer
gsl_monteMultidimensional integration using plain Monte Carlo (GSL)
gsl_mroot_hybridsMultidimensional root-finding algorithm using Powell's Hybrid method (GSL)
gsl_ode_controlControl structure for gsl_astep
gsl_poly_real_coeffSolve a general polynomial with real coefficients (GSL)
gsl_quadratic_real_coeffSolve a quadratic with real coefficients and complex roots (GSL)
gsl_quartic_realSolve a quartic with real coefficients and real roots (GSL)
gsl_quartic_real2Solve a quartic with real coefficients and real roots (GSL)
gsl_rk8pdEmbedded Runge-Kutta Prince-Dormand ODE stepper (GSL)
gsl_rk8pd_fastFaster embedded Runge-Kutta Prince-Dormand ODE stepper (GSL)
gsl_rkckCash-Karp embedded Runge-Kutta ODE stepper (GSL)
gsl_rkck_fastFaster Cash-Karp embedded Runge-Kutta ODE stepper (GSL)
gsl_rkf45Runge-Kutta-Fehlberg embedded Runge-Kutta ODE stepper (GSL)
gsl_rkf45_fastFaster Runge-Kutta-Fehlberg embedded Runge-Kutta ODE stepper (GSL)
gsl_rngaRandom number generator (GSL)
gsl_root_brentOne-dimensional root-finding (GSL)
gsl_root_stefSteffenson equation solver (GSL)
gsl_seriesSeries acceleration by Levin u-transform (GSL)
gsl_solver_HHGSL Householder solver
gsl_solver_LUGSL solver by LU decomposition
gsl_solver_QRGSL solver by QR decomposition
gsl_vegasMultidimensional integration using Vegas Monte Carlo (GSL)
hybrids_baseBase functions for gsl_mroot_hybrids
in_file_formatClass for input file formats [abstract base]
int_io_typeI/O object for int variables
inteBase integration class [abstract base]
io_baseI/O base class
io_managerManage I/O type information
io_tlateA template for adding I/O classes
io_type_infoUser interface to provide I/O type information
io_vtlateA template for adding I/O classes
jac_functBase for a square Jacobian where J is computed at x given y=f(x) [abstract base]
jac_funct_cmfptrConst member function pointer to a Jacobian
jac_funct_fptrFunction pointer to jacobian
jac_funct_mfptrMember function pointer to a Jacobian
jac_vfunctBase for a square Jacobian where J is computed at x given y=f(x) with arrays [abstract base]
jac_vfunct_cmfptrConst member function pointer to a Jacobian with arrays
jac_vfunct_fptrFunction pointer to jacobian with arrays
jac_vfunct_mfptrMember function pointer to a Jacobian with arrays
jacobianBase for providing a numerical jacobian [abstract base]
lanczosLanczos diagonalization
lib_settings_classA class to manage global library settings
linear_interpLinear interpolation (GSL)
linear_solverA generic solver for the linear system $ A x = b $ [abstract base]
linear_solver_hhGeneric Householder linear solver
linear_solver_luGeneric linear solver using LU decomposition
linear_solver_qrGeneric linear solver using QR decomposition
long_io_typeI/O object for long variables
mcarlo_inteMonte-Carlo integration [abstract base]
min_fitNon-linear least-squares fitting class with generic minimizer
min_fit::func_parA structure for passing information to the GSL functions for the min_fit class
minimizeOne-dimensional minimization [abstract base]
minimize_bktOne-dimensional bracketing minimization [abstract base]
minimize_deOne-dimensional minimization using derivatives [abstract base]
mm_functArray of multi-dimensional functions [abstract base]
mm_funct_cmfptrConst member function pointer to an array of multi-dimensional functions
mm_funct_cmfptr_noparConst member function pointer to an array of multi-dimensional functions with no parameters
mm_funct_fptrFunction pointer to array of multi-dimensional functions
mm_funct_fptr_noparFunction pointer to array of multi-dimensional functions with no parameters
mm_funct_gslFunction pointer to a gsl_multiroot_function
mm_funct_mfptrMember function pointer to an array of multi-dimensional functions
mm_funct_mfptr_noparMember function pointer to an array of multi-dimensional functions with no parameters
mm_vfunctArray of multi-dimensional functions with arrays [abstract base]
mm_vfunct_cmfptrConst member function pointer to an array of multi-dimensional functions with arrays
mm_vfunct_cmfptr_noparMember function pointer to an array of multi-dimensional functions with arrays with no parameters
mm_vfunct_fptrFunction pointer to array of multi-dimensional functions with arrays
mm_vfunct_fptr_noparFunction pointer to array of multi-dimensional functions with arrays and no parameters
mm_vfunct_gslFunction pointer to a gsl_multiroot_function with arrays
mm_vfunct_mfptrMember function pointer to an array of multi-dimensional functions with arrays
mm_vfunct_mfptr_noparConst member function pointer to an array of multi-dimensional functions with arrays with no parameters
mrootMultidimensional root-finding [abstract base]
multi_functMulti-dimensional function [abstract base]
multi_funct_cmfptrConst member function pointer to a multi-dimensional function
multi_funct_cmfptr_noerrConst member function pointer to a multi-dimensional function
multi_funct_fptrFunction pointer to a multi-dimensional function
multi_funct_fptr_noerrFunction pointer to a multi-dimensional function without error control
multi_funct_gslFunction pointer to a gsl_multimin_function
multi_funct_mfptrMember function pointer to a multi-dimensional function
multi_funct_mfptr_noerrMember function pointer to a multi-dimensional function
multi_inteMulti-dimensional integration over a hypercube [abstract base]
multi_minMultidimensional minimization [abstract base]
multi_min_fixMultidimensional minimizer fixing some variables and varying others
multi_vfunctMulti-dimensional function base with arrays [abstract base]
multi_vfunct_cmfptrMember function pointer to a multi-dimensional function with arrays
multi_vfunct_cmfptr_noerrMember function pointer to a multi-dimensional function with arrays
multi_vfunct_fptrFunction pointer to a multi-dimensional function with arrays
multi_vfunct_fptr_noerrFunction pointer to a multi-dimensional function with arrays and without error control
multi_vfunct_gslFunction pointer to a gsl_multimin_function with arrays
multi_vfunct_mfptrMember function pointer to a multi-dimensional function with arrays
multi_vfunct_mfptr_noerrMember function pointer to a multi-dimensional function with arrays
nonadapt_stepAn non-adaptive stepper implementation of adapt_step
o2scl_hybrid_state_tState class for gsl_mroot_hybrids
o2scl_interpInterpolation class
o2scl_interp_vecInterpolation class for pre-specified vector
ode_bv_multishootMultishooting
ode_bv_shootSolve boundary-value ODE problems by shooting
ode_bv_solveSolve boundary-value ODE problems with constant boundary conditions [abstract base]
ode_functOrdinary differential equation function [abstract base]
ode_funct_cmfptrProvide ODE functions in the form of const member function pointers
ode_funct_fptrProvide ODE functions in the form of function pointers
ode_funct_mfptrProvide ODE functions in the form of member function pointers
ode_it_functFunction class for ode_it_solve
ode_it_funct_fptrFunction pointer for ode_it_solve
ode_it_funct_mfptrMember function pointer for ode_it_solve
ode_it_solveODE solver using a generic linear solver to solve finite-difference equations
ode_iv_solveSolve an initial-value ODE problems given an adaptive ODE stepper
ode_jac_functOrdinary differential equation Jacobian [abstract base]
ode_jac_funct_cmfptrProvide ODE Jacobian in the form of const member function pointers
ode_jac_funct_fptrProvide ODE Jacobian in the form of function pointers
ode_jac_funct_mfptrProvide ODE Jacobian in the form of member function pointers
ode_jac_vfunctOrdinary differential equation Jacobian with arrays [abstract base]
ode_jac_vfunct_cmfptrProvide ODE Jacobian in the form of const member function pointers
ode_jac_vfunct_fptrFunction pointer to a function
ode_jac_vfunct_mfptrProvide ODE Jacobian in the form of member function pointers
ode_vfunctOrdinary differential equation function with arrays [abstract base]
ode_vfunct_cmfptrProvide ODE functions in the form of const member function pointers
ode_vfunct_fptrFunction pointer to a function
ode_vfunct_mfptrProvide ODE functions in the form of member function pointers
odestepODE stepper base [abstract base]
ofvectorA vector where the memory allocation is performed in the constructor
ofvector_cxA complex vector where the memory allocation is performed in the constructor
omatrix_allocA simple class to provide an allocate() function for omatrix
omatrix_array_tlateCreate a matrix from an array
omatrix_base_tlateA base class for omatrix and omatrix_view
omatrix_col_tlateCreate a vector from a column of a matrix
omatrix_const_col_tlateCreate a const vector from a column of a matrix
omatrix_const_diag_tlateCreate a vector from the main diagonal
omatrix_const_row_tlateCreate a const vector from a row of a matrix
omatrix_const_view_tlateA const matrix view of omatrix objects
omatrix_cx_col_tlateCreate a vector from a column of a matrix
omatrix_cx_const_col_tlateCreate a vector from a column of a matrix
omatrix_cx_const_row_tlateCreate a vector from a row of a matrix
omatrix_cx_row_tlateCreate a vector from a row of a matrix
omatrix_cx_tlateA matrix of double-precision numbers
omatrix_cx_view_tlateA matrix view of double-precision numbers
omatrix_diag_tlateCreate a vector from the main diagonal
omatrix_row_tlateCreate a vector from a row of a matrix
omatrix_tlateA matrix of double-precision numbers
omatrix_view_tlateA matrix view of double-precision numbers
ool_constr_mminConstrained multidimensional minimization (OOL) [abstract base]
ool_hfunctHessian product function for ool_constr_mmin [abstract base]
ool_hfunct_fptrA hessian product supplied by a function pointer
ool_hfunct_mfptrA hessian product supplied by a member function pointer
ool_hvfunctHessian product function base for ool_constr_mmin using arrays
ool_hvfunct_fptrA hessian product supplied by a function pointer using arrays
ool_hvfunct_mfptrA hessian product supplied by a member function pointer using arrays
ool_mmin_gencanConstrained minimization by the "GENCAN" method (OOL)
ool_mmin_pgradConstrained minimization by the projected gradient method (OOL)
ool_mmin_spgConstrained minimization by the spectral projected gradient method (OOL)
other_iocSetup I/O for series acceleration
other_todos_and_bugsAn empty class to add some items to the todo and bug lists
out_file_formatClass for output file formats [abstract base]
ovector_allocA simple class to provide an allocate() function for ovector
ovector_array_stride_tlateCreate a vector from an array with a stride
ovector_array_tlateCreate a vector from an array
ovector_base_tlateA base class for ovector and ovector_view
ovector_const_array_stride_tlateCreate a const vector from an array with a stride
ovector_const_array_tlateCreate a const vector from an array
ovector_const_reverse_tlateReversed view of a vector
ovector_const_subvector_reverse_tlateReversed view of a const subvector
ovector_const_subvector_tlateCreate a const vector from a subvector of another vector
ovector_const_view_tlateA const vector view with finite stride
ovector_cx_array_stride_tlateCreate a vector from an array with a stride
ovector_cx_array_tlateCreate a vector from an array
ovector_cx_const_array_stride_tlateCreate a vector from an array_stride
ovector_cx_const_array_tlateCreate a vector from an array
ovector_cx_const_subvector_tlateCreate a vector from a subvector of another
ovector_cx_imag_tlateCreate a imaginary vector from the imaginary parts of a complex vector
ovector_cx_real_tlateCreate a real vector from the real parts of a complex vector
ovector_cx_subvector_tlateCreate a vector from a subvector of another
ovector_cx_tlateA vector of double-precision numbers
ovector_cx_view_tlateA vector view of double-precision numbers
ovector_int_allocA simple class to provide an allocate() function for ovector_int
ovector_reverse_tlateReversed view of a vector
ovector_subvector_reverse_tlateReversed view of a subvector
ovector_subvector_tlateCreate a vector from a subvector of another
ovector_tlateA vector with finite stride
ovector_view_tlateA vector view with finite stride
permutationA permutation
pinsideTest line intersection and point inside polygon
pinside::lineInternal line definition for pinside
pinside::pointInternal point definition for pinside
planar_intpInterpolate among two independent variables with planes
pointer_2d_allocA simple class to provide an allocate() function for pointers
pointer_allocA simple class to provide an allocate() function for pointers
pointer_inputA pointer input structure
pointer_outputA pointer output structure
poly_complexSolve a general polynomial with complex coefficients [abstract base]
poly_real_coeffSolve a general polynomial with real coefficients and complex roots [abstract base]
polylogPolylogarithms (approximate) $ Li_n(x)$
quadratic_complexSolve a quadratic polynomial with complex coefficients and complex roots [abstract base]
quadratic_realSolve a quadratic polynomial with real coefficients and real roots [abstract base]
quadratic_real_coeffSolve a quadratic polynomial with real coefficients and complex roots [abstract base]
quadratic_std_complexSolve a quadratic with complex coefficients and complex roots
quartic_complexSolve a quartic polynomial with complex coefficients and complex roots [abstract base]
quartic_realSolve a quartic polynomial with real coefficients and real roots [abstract base]
quartic_real_coeffSolve a quartic polynomial with real coefficients and complex roots [abstract base]
rngaRandom number generator base
root1-dimensional solver [abstract base]
root_bkt1-dimensional bracketing solver [abstract base]
root_de1-dimensional with solver with derivatives [abstract base]
search_vecSearching class for monotonic data with caching
sim_annealSimulated annealing base
simple_gradSimple automatic computation of gradient by finite differencing
simple_grad_arraySimple automatic computation of gradient by finite differencing with arrays
simple_jacobianSimple automatic Jacobian
simple_quartic_complexSolve a quartic with complex coefficients and complex roots
simple_quartic_realSolve a quartic with real coefficients and real roots
sma_interpA specialization of smart_interp for C-style double arrays
sma_interp_vecA specialization of smart_interp_vec for C-style double arrays
smart_interpSmart interpolation class
smart_interp_vecSmart interpolation class with pre-specified vectors
string_compSimple string comparison
string_io_typeI/O object for string variables
tableData table class
table3dA data structure containing many slices of two-dimensional data points defined on a grid
table::col_sColumn structure for table [protected]
table::sortd_sA structure for sorting in table [protected]
tensorTensor class with arbitrary dimensions
tensor1Rank 1 tensor
tensor2Rank 2 tensor
tensor3Rank 3 tensor
tensor4Rank 4 tensor
tensor_gridTensor class with arbitrary dimensions with a grid
tensor_grid2Rank 2 tensor with a grid
tensor_grid3Rank 3 tensor with a grid
tensor_grid4Rank 4 tensor with a grid
test_mgrA class to manage testing and record success and failure
text_in_fileAn input text file
text_out_fileAn output text file
twod_eqi_intpTwo-dimensional interpolation for equally-spaced intervals
twod_intpTwo-dimensional interpolation class
ufmatrixA matrix where the memory allocation is performed in the constructor
ufmatrix_cxA matrix where the memory allocation is performed in the constructor
ufvectorA vector with unit-stride where the memory allocation is performed in the constructor
umatrix_allocA simple class to provide an allocate() function for umatrix
umatrix_base_tlateA matrix view of double-precision numbers
umatrix_const_row_tlateCreate a const vector from a row of a matrix
umatrix_const_view_tlateA matrix view of double-precision numbers
umatrix_cx_allocA simple class to provide an allocate() function for umatrix_cx
umatrix_cx_const_row_tlateCreate a const vector from a row of a matrix
umatrix_cx_row_tlateCreate a vector from a row of a matrix
umatrix_cx_tlateA matrix of double-precision numbers
umatrix_cx_view_tlateA matrix view of complex numbers
umatrix_row_tlateCreate a vector from a row of a matrix
umatrix_tlateA matrix of double-precision numbers
umatrix_view_tlateA matrix view of double-precision numbers
uvector_allocA simple class to provide an allocate() function for uvector
uvector_array_tlateCreate a vector from an array
uvector_base_tlateDesc
uvector_const_array_tlateCreate a vector from an const array
uvector_const_subvector_tlateCreate a const vector from a subvector of another vector
uvector_const_view_tlateA const vector view with unit stride
uvector_cx_array_tlateCreate a vector from an array
uvector_cx_const_array_tlateCreate a vector from an array
uvector_cx_const_subvector_tlateCreate a vector from a subvector of another
uvector_cx_subvector_tlateCreate a vector from a subvector of another
uvector_cx_tlateA vector of double-precision numbers with unit stride
uvector_cx_view_tlateA vector view of complex numbers with unit stride
uvector_int_allocA simple class to provide an allocate() function for uvector_int
uvector_subvector_tlateCreate a vector from a subvector of another
uvector_tlateA vector with unit stride
uvector_view_tlateA base class for uvectors
word_io_typeI/O object for words

Documentation generated with Doxygen and provided under the GNU Free Documentation License. See License Information for details.

Project hosting provided by SourceForge.net Logo, O2scl Sourceforge Project Page