O2scl Data Structures

Here are the data structures with brief descriptions:
adapt_stepAdaptive stepper base
akima_interpAkima spline interpolation (GSL)
akima_peri_interpAkima spline interpolation with periodic boundary conditions (GSL)
array_2d_allocA simple class to provide an allocate() function for 2-dimensional arrays
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_rowExtract a row of a C-style 2d-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
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
cmd_line_argA command-line argument
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_entryAn entry in a collection
columnifyCreate nicely formatted columns from a table of strings
comm_optionCommand for interactive mode in cli
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
comp_gen_inte::od_parmsParameters to send to the 1-d integration functions
composite_inteNaive multi-dimensional integration over a hypercube
composite_inte::od_parmsParameters to send to the 1-d integration functions
contourCalculate contour lines from a two-dimensional data set
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
cubic_realSolve a cubic polynomial with real coefficients and real roots
cubic_real_coeffSolve a cubic polynomial with real coefficients and complex roots
cubic_std_complexSolve a cubic with complex coefficients and complex roots
derivNumerical differentiation 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
eqi_derivDerivatives for equally-spaced abscissas
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 base class
fit_fix_parsMultidimensional fitting fixing some parameters and varying others
fit_functFitting function base
fit_funct_fptrFunction pointer fitting function
fit_funct_mfptrMember function pointer fitting function
fit_vfunctFitting function base
fit_vfunct_fptrFunction pointer fitting function
fit_vfunct_mfptrMember function pointer fitting function
functOne-dimensional function base
funct_fptrFunction pointer to a function
funct_fptr_noerrFunction pointer to a function
funct_fptr_noparFunction pointer to a function
funct_mfptrMember function pointer to a one-dimensional function
funct_mfptr_noerrMember function pointer to a one-dimensional function
funct_mfptr_noparMember function pointer to a one-dimensional function
gaussian_2dGenerate two random numbers from a normal distribution
gen_inteGeneralized multi-dimensional integration base
gen_test_numberGenerate number sequence for testing
grad_functBase class for a gradient function
grad_funct_fptrFunction pointer to a gradient
grad_funct_mfptrMember function pointer to a gradient
grad_vfunctBase class for a gradient function using arrays
grad_vfunct_fptrFunction pointer to a gradient
grad_vfunct_mfptrMember function pointer to a gradient
gradientBase class for automatically computing gradients
gradient_arrayBase class for automatically computing gradients with arrays
gsl_annealMultidimensional minimization by simulated annealing (GSL)
gsl_astepAdaptive ODE stepper (GSL)
gsl_astep::gsl_ode_controlControl structure for gsl_astep [public typedef]
gsl_astep::gsl_odeiv_evolveThe evolution object for gsl_astep [protected subclass]
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_HH_solverGSL Householder solver
gsl_inteGSL integration base
gsl_inte_chebChebyshev integration (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 routines
gsl_inte_transformIntegrate a function with a singularity (GSL)
gsl_LU_solverGSL solver by LU decomposition
gsl_min_brentOne-dimensional minimization (GSL)
gsl_miserMultidimensional integration using Miser Miser 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_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_linminThe line minimizer for gsl_mmin_bfgs2
gsl_mmin_simpMultidimensional minimization by the Simplex method (GSL)
gsl_mmin_simp_bBase routines for the GSL simplex minimizer
gsl_mmin_simp_b::simp_state_tState type for GSL simplex minimizer
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_mroot_hybrids::o2scl_hybrid_state_tA structure for gsl_mroot_hybrids
gsl_poly_real_coeffSolve a general polynomial with real coefficients (GSL)
gsl_QR_solverGSL solver by QR decomposition
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_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_vegasMultidimensional integration using Vegas Monte Carlo (GSL)
hybrids_baseBase functions for gsl_mroot_hybrids
in_file_formatAbstract base class for input file formats
int_io_typeI/O object for int variables
inteBase integration class
io_baseI/O base class
io_managerManage I/O type information
io_tlateA template for adding I/O classes (documents template io_tlate)
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)
jac_funct_fptrFunction pointer to jacobian
jac_funct_mfptrMember function pointer to a Jacobian
jacobianBase for providing a numerical jacobian
lanczosLanczos diagonalization
lib_settings_classA class to manage testing and record success and failure
linear_interpLinear interpolation (GSL)
linear_solverA generic solver for the linear system $ A x = b $
long_io_typeI/O object for long variables
mcarlo_inteMonte-Carlo integration base
min_fitNon-linear least-squares fitting class with generic minimizer
min_fit::func_parA structure for passing information to the GSL functions
minimizeNumerical differentiation base
mm_functArray of multi-dimensional functions
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
mm_vfunctArray of multi-dimensional functions with arrays
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_noparMember function pointer to an array of multi-dimensional functions with arrays
mrootMultidimensional root-finding base
multi_functMulti-dimensional function base
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 base class
multi_minMultidimensional minimization base
multi_min_fixMultidimensional minimizer fixing some variables and varying others
multi_vfunctMulti-dimensional function base 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
naive_metropolisNaive metropolis monte carlo integration
naive_quartic_complexSolve a quartic with complex coefficients and complex roots
naive_quartic_realSolve a quartic with real coefficients and real roots
nonadapt_stepAn non-adaptive stepper implementation of adapt_step
o2scl_interpInterpolation class
o2scl_interp_vecInterpolation class for pre-specified vector
ode_bv_shootSolve boundary-value ODE problems by shooting
ode_bv_solveSolve boundary-value ODE problems
ode_functOrdinary differential equation function base
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_make_CoordMake a coordinate matrix 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_vfunctOrdinary differential equation function base for arrays
ode_vfunct_fptrFunction pointer to a function
ode_vfunct_mfptrProvide ODE functions in the form of member function pointers
odestepODE stepper base
ofmatrixA matrix where the memory allocation is performed in the constructor
ofvectorA vector where the memory allocation is performed in the constructor
ofvector_cxA 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_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_row_tlateCreate a const vector from a row of a matrix
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 base (OOL)
ool_hfunctHessian product function base for ool_constr_mmin
ool_hfunct_fptrA hessian product supplied by a function pointer
ool_hfunct_mfptrA hessian product supplied by a member function pointer
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)
ool_vhfunctHessian product function base for ool_constr_mmin using arrays
ool_vhfunct_fptrA hessian product supplied by a function pointer using arrays
ool_vhfunct_mfptrA hessian product supplied by a member function pointer using arrays
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_formatAbstract base class for output file formats
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_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_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
pinside::pointInternal point definition
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_complexBase class for solving a general polynomial with complex coefficients
poly_real_coeffBase class for solving a general polynomial with real coefficients and complex roots
polylogPolylogarithms (approximate) $ Li_n(x)$
quad_intpInterpolate a function of two independent variables with a quadratic polynomial
quadratic_complexSolve a quadratic polynomial with complex coefficients and complex roots
quadratic_realSolve a quadratic polynomial with real coefficients and real roots
quadratic_real_coeffSolve a quadratic polynomial with real coefficients and complex roots
quadratic_std_complexSolve a quadratic with complex coefficients and complex roots
quartic_complexSolve a quartic polynomial with complex coefficients and complex roots
quartic_realSolve a quartic polynomial with real coefficients and real roots
quartic_real_coeffSolve a quartic polynomial with real coefficients and complex roots
rngaRandom number generator base
root1-dimensional solver base class
search_vecSearching class for monotonic data
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
sma_interpA specialization of smart_interp for C-style double arrays
sma_interp_vecA specialization of smart_interp_vec for C-style arrays
smart_interpSmart interpolation class
smart_interp_vecSmart interpolation class with pre-specified vectors
string_compNaive string comparison
string_io_typeI/O object for string variables
tableData table
table::col_sColumn structure
table::sortd_sA structure for sorting
tensorTensor class with arbitrary dimensions
tensor1Rank 1 tensor
tensor2Rank 2 tensor
tensor3Rank 3 tensor
tensor4Rank 4 tensor
tensor_gridTensor class with arbitrary dimensions
tensor_grid3Rank 3 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
timer_clockProvide an interface for timing execution using clock()
timer_gettodProvide an interface for timing execution using gettimeofday()
tptr_geoseriesTemperature schedule for a geometric series
tptr_scheduleSimulated annealing temperature schedule base
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_const_row_tlateCreate a const vector from a row of a matrix
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_const_array_tlateCreate a vector from an const array
uvector_const_subvector_tlateCreate a const vector from a subvector of another vector
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 vector view with unit stride
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