![]() |
Object-oriented Scientific Computing Library: Version 0.910
|
adapt_step< func_t, vec_t, alloc_vec_t, alloc_t > | Adaptive stepper [abstract base] |
akima_interp< vec_t > | Akima spline interpolation (GSL) |
akima_peri_interp< vec_t > | Akima spline interpolation with periodic boundary conditions (GSL) |
anneal_mt< param_t, param_vec_t, func_t, vec_t, alloc_vec_t, alloc_t, rng_t > | Multidimensional minimization by simulated annealing (Boost multi-threaded version) |
array_2d_alloc< mat_t > | A simple class to provide an allocate() function for 2-dimensional arrays |
array_2d_col< R, C, data_t > | Column of a 2d array |
array_2d_row< array_2d_t, data_t > | Row of a 2d array |
array_alloc< vec_t > | A simple class to provide an allocate() function for arrays |
array_const_reverse< sz > | A simple class which reverses the order of an array |
array_const_subvector | A simple subvector class for a const array (without error checking) |
array_const_subvector_reverse | Reverse a subvector of a const array |
array_interp< n > | A specialization of o2scl_interp for C-style double arrays |
array_interp_vec< arr_t > | A specialization of o2scl_interp_vec for C-style arrays |
array_reverse< sz > | A simple class which reverses the order of an array |
array_subvector | A simple subvector class for an array (without error checking) |
array_subvector_reverse | Reverse a subvector of an array |
base_interp< vec_t > | Base low-level interpolation class [abstract base] |
base_interp_mgr< vec_t > | A base interpolation object manager [abstract base] |
bin_size | Determine bin size (CERNLIB) |
cern_adapt< func_t, nsub > | Adaptive integration (CERNLIB) |
cern_cauchy< func_t > | Cauchy principal value integration (CERNLIB) |
cern_cubic_real_coeff | Solve a cubic with real coefficients and complex roots (CERNLIB) |
cern_deriv< func_t > | Numerical differentiation routine (CERNLIB) |
cern_gauss< func_t > | Gaussian quadrature (CERNLIB) |
cern_gauss56< func_t > | 5,6-point Gaussian quadrature (CERNLIB) |
cern_minimize< func_t > | One-dimensional minimization (CERNLIB) |
cern_mroot< func_t, vec_t, alloc_vec_t, alloc_t, jfunc_t > | Multi-dimensional mroot-finding routine (CERNLIB) |
cern_mroot_root< func_t > | One-dimensional version of cern_mroot |
cern_quartic_real_coeff | Solve a quartic with real coefficients and complex roots (CERNLIB) |
cern_root< func_t > | One-dimensional root-finding routine (CERNLIB) |
cli | Configurable command-line interface |
cli_readline | An extension to cli which uses readline |
cmd_line_arg | A command-line argument for cli |
table::col_s | Column structure for table [protected] |
columnify | Create nicely formatted columns from a table of strings |
comm_option_fptr | Function pointer for cli command function |
comm_option_funct | Base for cli command function |
comm_option_mfptr< tclass > | Member function pointer for cli command function |
comm_option_s | Command for interactive mode in cli |
comp_gen_inte< func_t, lfunc_t, ufunc_t, vec_t, alloc_vec_t, alloc_t > | Naive generalized multi-dimensional integration |
composite_inte< func_t, vec_t, alloc_vec_t, alloc_t > | Naive multi-dimensional integration over a hypercube |
ovector_const_view_tlate< data_t, vparent_t, block_t >::const_iterator | A const iterator for ovectors |
contour | Calculate contour lines from a two-dimensional data set |
contour_line | A contour line |
convert_units | Convert units |
convert_units_gnu | Convert units using a system call to GNU units |
cspline_interp< vec_t > | Cubic spline interpolation (GSL) |
cspline_peri_interp< vec_t > | Cubic spline interpolation with periodic boundary conditions (GSL) |
cubic_complex | Solve a cubic polynomial with complex coefficients and complex roots [abstract base] |
cubic_real | Solve a cubic polynomial with real coefficients and real roots [abstract base] |
cubic_real_coeff | Solve a cubic polynomial with real coefficients and complex roots [abstract base] |
cubic_std_complex | Solve a cubic with complex coefficients and complex roots |
def_interp_mgr< vec_t, interp_t > | A base interpolation object manager template |
deriv< func_t > | Numerical differentiation base [abstract base] |
deriv< func_t >::dpars | A structure for passing the function to second and third derivatives [protected] |
edge_crossings | Edges for the contour class |
exact_jacobian< func_t, vec_t, mat_t >::ej_parms | Parameter structure for passing information |
eqi_deriv< func_t, vec_t > | Derivatives for equally-spaced abscissas |
err_hnd_cpp | Error handler to throw C++ exceptions |
err_hnd_gsl | The error handler |
err_hnd_type | Class defining an error handler [abstract base] |
exact_jacobian< func_t, vec_t, mat_t > | A direct calculation of the jacobian using a deriv object |
exc_exception | Generic exception |
exc_invalid_argument | Invalid argument exception |
exc_ios_failure | I/O failure error exception |
exc_logic_error | Logic error exception |
exc_overflow_error | Overflow error runtime exception |
exc_range_error | Range error runtime exception |
exc_runtime_error | Generic runtime error exception |
expect_val | Expectation value base class |
gsl_inte_singular< func_t >::extrapolation_table | A structure for extrapolation for gsl_inte_qags |
fit_base< func_t, vec_t, mat_t > | Non-linear least-squares fitting [abstract base] |
fit_fix_pars< bool_vec_t > | Multidimensional fitting fixing some parameters and varying others |
fit_funct< vec_t > | Fitting function [abstract base] |
fit_funct_cmfptr< tclass, vec_t > | Const member function pointer fitting function |
fit_funct_fptr< vec_t > | Function pointer fitting function |
fit_funct_mfptr< tclass, vec_t > | Member function pointer fitting function |
format_float | Format a floating point number into a Latex or HTML string |
gsl_fit< func_t, vec_t, mat_t, bool_vec_t >::func_par | A structure for passing to the functions func(), dfunc(), and fdfunc() |
min_fit< func_t, vec_t, mat_t >::func_par | A structure for passing information to the GSL functions for the min_fit class |
funct | One-dimensional function [abstract base] |
funct_cmfptr< tclass > | Const member function pointer to a one-dimensional function |
funct_cmfptr_param< tclass, param_t > | Const member function pointer to a one-dimensional function with a parameter |
funct_fptr | Function pointer to a function |
funct_fptr_param< param_t > | Function pointer to a function with a parameter |
funct_mfptr< tclass > | Member function pointer to a one-dimensional function |
funct_mfptr_param< tclass, param_t > | Member function pointer to a one-dimensional function with a parameter |
gen_inte< func_t, lfunc_t, ufunc_t, vec_t > | Generalized multi-dimensional integration [abstract base] |
gen_test_number< tot > | Generate number sequence for testing |
grad_funct< vec_t > | Array of multi-dimensional functions [abstract base] |
grad_funct_cmfptr< tclass, vec_t > | Const member function pointer to an array of multi-dimensional functions |
grad_funct_fptr< vec_t > | Function pointer to array of multi-dimensional functions |
grad_funct_fptr_param< param_t, vec_t > | Function pointer to array of multi-dimensional functions |
grad_funct_mfptr< tclass, vec_t > | Member function pointer to an array of multi-dimensional functions |
grad_funct_mfptr_param< tclass, param_t, vec_t > | Member function pointer to an array of multi-dimensional functions |
gradient< func_t, vec_t > | Class for automatically computing gradients [abstract base] |
gsl_anneal< func_t, vec_t, alloc_vec_t, alloc_t, rng_t > | Multidimensional minimization by simulated annealing (GSL) |
gsl_astep< func_t, vec_t, alloc_vec_t, alloc_t > | Adaptive ODE stepper (GSL) |
gsl_astep_old< func_t, vec_t, alloc_vec_t, alloc_t > | Adaptive ODE stepper (GSL) |
gsl_bsimp< func_t, jac_func_t, vec_t, alloc_vec_t, alloc_t, mat_t, alloc_mat_t, mat_alloc_t > | Bulirsch-Stoer implicit ODE stepper (GSL) |
gsl_chebapp | Chebyshev approximation (GSL) |
gsl_cubic_real_coeff | Solve a cubic with real coefficients and complex roots (GSL) |
gsl_deriv< func_t > | Numerical differentiation (GSL) |
gsl_fft | Real mixed-radix fast Fourier transform |
gsl_fit< func_t, vec_t, mat_t, bool_vec_t > | Non-linear least-squares fitting class (GSL) |
gsl_inte | GSL integration base |
gsl_inte_cheb< func_t > | Chebyshev integration base class (GSL) |
gsl_inte_kronrod< func_t > | Basic Gauss-Kronrod integration class (GSL) |
gsl_inte_qag< func_t > | Adaptive numerical integration of a function (without singularities) on a bounded interval (GSL) |
gsl_inte_qagi< func_t > | Integrate a function over the interval ![]() |
gsl_inte_qagil< func_t > | Integrate a function over the interval ![]() |
gsl_inte_qagiu< func_t > | Integrate a function over the interval ![]() |
gsl_inte_qags< func_t > | Integrate a function with a singularity (GSL) |
gsl_inte_qawc< func_t > | Adaptive Cauchy principal value integration (GSL) |
gsl_inte_qawf_cos< func_t > | Adaptive integration a function with finite limits of integration (GSL) |
gsl_inte_qawf_sin< func_t > | Adaptive integration for oscillatory integrals (GSL) |
gsl_inte_qawo_cos< func_t > | Adaptive integration a function with finite limits of integration (GSL) |
gsl_inte_qawo_sin< func_t > | Adaptive integration for oscillatory integrals (GSL) |
gsl_inte_qaws< func_t > | Adaptive integration with with algebraic-logarithmic singularities at the end-points (GSL) |
gsl_inte_qng< func_t > | Non-adaptive integration from a to b (GSL) |
gsl_inte_singular< func_t > | Base class for integrating a function with a singularity (GSL) |
gsl_inte_transform< func_t > | Integrate a function with a singularity (GSL) [abstract base] |
gsl_inte_workspace | Integration workspace for the GSL integrators |
gsl_matrix | |
gsl_matrix_int | |
gsl_min_brent< func_t > | One-dimensional minimization using Brent's method (GSL) |
gsl_min_quad_golden< func_t > | Minimization of a function using the safeguarded step-length algorithm of Gill and Murray [GSL] |
gsl_miser< func_t, rng_t, vec_t, alloc_vec_t, alloc_t > | Multidimensional integration using the MISER Monte Carlo algorithm (GSL) |
gsl_mmin_base< func_t, vec_t, alloc_vec_t, alloc_t, dfunc_t, auto_grad_t, def_auto_grad_t > | Base minimization routines for gsl_mmin_conf and gsl_mmin_conp |
gsl_mmin_bfgs2< func_t, vec_t, alloc_vec_t, alloc_t, dfunc_t, auto_grad_t, def_auto_grad_t > | Multidimensional minimization by the BFGS algorithm (GSL) |
gsl_mmin_conf< func_t, vec_t, alloc_vec_t, alloc_t, dfunc_t, auto_grad_t, def_auto_grad_t > | Multidimensional minimization by the Fletcher-Reeves conjugate gradient algorithm (GSL) |
gsl_mmin_conp< func_t, vec_t, alloc_vec_t, alloc_t, dfunc_t, auto_grad_t, def_auto_grad_t > | Multidimensional minimization by the Polak-Ribiere conjugate gradient algorithm (GSL) |
gsl_mmin_linmin2 | The line minimizer for gsl_mmin_bfgs2 |
gsl_mmin_simp< func_t, vec_t, alloc_vec_t, alloc_t > | Multidimensional minimization by the Simplex method (GSL) |
gsl_mmin_simp2< func_t, vec_t, alloc_vec_t, alloc_t > | Multidimensional minimization by the Simplex method (v2) (GSL) |
gsl_mmin_wrap_base | Virtual base for the gsl_mmin_bfgs2 wrapper |
gsl_mmin_wrapper< func_t, vec_t, alloc_vec_t, alloc_t, dfunc_t, auto_grad_t > | Wrapper class for the gsl_mmin_bfgs2 minimizer |
gsl_monte< func_t, rng_t, vec_t, alloc_vec_t, alloc_t > | Multidimensional integration using plain Monte Carlo (GSL) |
gsl_mroot_broyden< func_t, vec_t, alloc_vec_t, alloc_t, mat_t, alloc_mat_t, mat_alloc_t, jfunc_t > | Multidimensional root-finding using Broyden's method (GSL) |
gsl_mroot_hybrids< func_t, vec_t, alloc_vec_t, alloc_t, mat_t, alloc_mat_t, mat_alloc_t, jfunc_t > | Multidimensional root-finding algorithm using Powell's Hybrid method (GSL) |
gsl_ode_control< vec_t > | Control structure for gsl_astep |
gsl_poly_real_coeff | Solve a general polynomial with real coefficients (GSL) |
gsl_quadratic_real_coeff | Solve a quadratic with real coefficients and complex roots (GSL) |
gsl_quartic_real | Solve a quartic with real coefficients and real roots (GSL) |
gsl_quartic_real2 | Solve a quartic with real coefficients and real roots (GSL) |
gsl_rk8pd< func_t, vec_t, alloc_vec_t, alloc_t > | Embedded Runge-Kutta Prince-Dormand ODE stepper (GSL) |
gsl_rk8pd_fast< N, func_t, vec_t, alloc_vec_t, alloc_t > | Faster embedded Runge-Kutta Prince-Dormand ODE stepper (GSL) |
gsl_rkck< func_t, vec_t, alloc_vec_t, alloc_t > | Cash-Karp embedded Runge-Kutta ODE stepper (GSL) |
gsl_rkck_fast< N, func_t, vec_t, alloc_vec_t, alloc_t > | Faster Cash-Karp embedded Runge-Kutta ODE stepper (GSL) |
gsl_rkf45< func_t, vec_t, alloc_vec_t, alloc_t > | Runge-Kutta-Fehlberg embedded Runge-Kutta ODE stepper (GSL) |
gsl_rkf45_fast< N, func_t, vec_t, alloc_vec_t, alloc_t > | Faster Runge-Kutta-Fehlberg embedded Runge-Kutta ODE stepper (GSL) |
gsl_rnga | Random number generator (GSL) |
gsl_root_brent< func_t > | One-dimensional root-finding (GSL) |
gsl_root_stef< func_t, dfunc_t > | Steffenson equation solver (GSL) |
gsl_series | Series acceleration by Levin u-transform (GSL) |
gsl_smooth | Smooth a GSL vector using GSL bsplines |
o2scl_linalg::gsl_solver_HH | GSL Householder solver |
o2scl_linalg::gsl_solver_LU | GSL solver by LU decomposition |
o2scl_linalg::gsl_solver_QR | GSL solver by QR decomposition |
gsl_vector_norm | Norm object for gsl vectors |
gsl_vegas< func_t, rng_t, vec_t, alloc_vec_t, alloc_t > | Multidimensional integration using Vegas Monte Carlo (GSL) |
hdf_file | Store data in an HDF5 file |
hist | A one-dimensional histogram class |
hist_2d | A two-dimensional histogram class |
hist_ev | A set expectation values for histogram bins |
hybrids_base | Base functions for gsl_mroot_hybrids |
inte< func_t > | Base integration class [abstract base] |
iterate_parms | A structure to pass information to and from iterate_func() |
ovector_const_view_tlate< data_t, vparent_t, block_t >::iterator | An iterator for ovectors |
jac_funct< vec_t, mat_t > | Base for a square Jacobian where J is computed at x given y=f(x) [abstract base] |
jac_funct_cmfptr< tclass, vec_t, mat_t > | Const member function pointer to a Jacobian |
jac_funct_fptr< vec_t, mat_t > | Function pointer to jacobian |
jac_funct_mfptr< tclass, vec_t, mat_t > | Member function pointer to a Jacobian |
jacobian< func_t, vec_t, mat_t > | Base for providing a numerical jacobian [abstract base] |
lanczos< vec_t, mat_t, alloc_vec_t, alloc_t > | Lanczos diagonalization |
lib_settings_class | A class to manage global library settings |
pinside::line | Internal line definition for pinside |
linear_interp< vec_t > | Linear interpolation (GSL) |
o2scl_linalg::linear_solver< vec_t, mat_t > | A generic solver for the linear system ![]() |
o2scl_linalg::linear_solver_hh< vec_t, mat_t > | Generic Householder linear solver |
o2scl_linalg::linear_solver_lu< vec_t, mat_t > | Generic linear solver using LU decomposition |
o2scl_linalg::linear_solver_qr< vec_t, mat_t > | Generic linear solver using QR decomposition |
matrix_row< mat_t > | Create a vector-like class from a row of a matrix |
mcarlo_inte< func_t, rng_t, vec_t > | Monte-Carlo integration [abstract base] |
min_fit< func_t, vec_t, mat_t > | Non-linear least-squares fitting class with generic minimizer |
minimize< func_t, dfunc_t > | One-dimensional minimization [abstract base] |
minimize_bkt< func_t, dfunc_t > | One-dimensional bracketing minimization [abstract base] |
minimize_de< func_t, dfunc_t > | One-dimensional minimization using derivatives [abstract base] |
mm_funct< vec_t > | Array of multi-dimensional functions [abstract base] |
mm_funct_cmfptr< tclass, vec_t > | Const member function pointer to an array of multi-dimensional functions |
mm_funct_fptr< vec_t > | Function pointer to array of multi-dimensional functions |
mm_funct_fptr_param< param_t, vec_t > | Function pointer to array of multi-dimensional functions |
mm_funct_mfptr< tclass, vec_t > | Member function pointer to an array of multi-dimensional functions |
mm_funct_mfptr_param< tclass, param_t, vec_t > | Member function pointer to an array of multi-dimensional functions |
mroot< func_t, vec_t, jfunc_t > | Multidimensional root-finding [abstract base] |
multi_funct< vec_t > | Multi-dimensional function [abstract base] |
multi_funct_cmfptr< tclass, vec_t > | Const member function pointer to a multi-dimensional function |
multi_funct_fptr< vec_t > | Function pointer to a multi-dimensional function |
multi_funct_fptr_param< param_t, vec_t > | Function pointer to a multi-dimensional function |
multi_funct_mfptr< tclass, vec_t > | Member function pointer to a multi-dimensional function |
multi_funct_mfptr_param< tclass, param_t, vec_t > | Member function pointer to a multi-dimensional function |
multi_inte< func_t, vec_t > | Multi-dimensional integration over a hypercube [abstract base] |
multi_min< func_t, dfunc_t, vec_t > | Multidimensional minimization [abstract base] |
multi_min_fix< bool_vec_t > | Multidimensional minimizer fixing some variables and varying others |
nonadapt_step< func_t, vec_t, alloc_vec_t, alloc_t > | An non-adaptive stepper implementation of adapt_step |
o2_int_shared_ptr< T > | The internal shared pointer class used if no TR1 or Boost implementation is available |
o2_shared_ptr< T > | A struct to provide the shared_ptr type |
o2scl_interp< vec_t > | Interpolation class |
o2scl_interp_vec< vec_t > | Interpolation class for pre-specified vector |
ode_bv_mshoot< func_t, mat_t, vec_t, alloc_vec_t, alloc_t, vec_int_t > | Solve boundary-value ODE problems by multishooting with a generic nonlinear solver |
ode_bv_multishoot< func_t, vec_t, alloc_vec_t, alloc_t, vec_int_t, mat_t > | Multishooting |
ode_bv_shoot< func_t, vec_t, alloc_vec_t, alloc_t, vec_int_t > | Solve boundary-value ODE problems by shooting from one boundary to the other |
ode_bv_shoot_grid< mat_t, mat_row_t, func_t, vec_t, alloc_vec_t, alloc_t, vec_int_t > | Solve boundary-value ODE problems by shooting from one boundary to the other on a grid |
ode_bv_solve | Base class for boundary-value ODE solvers |
ode_funct< vec_t > | Ordinary differential equation function [abstract base] |
ode_funct_cmfptr< tclass, vec_t > | Provide ODE functions in the form of const member function pointers |
ode_funct_fptr< vec_t > | Provide ODE functions in the form of function pointers |
ode_funct_fptr_param< param_t, vec_t > | Provide ODE functions in the form of function pointers |
ode_funct_mfptr< tclass, vec_t > | Provide ODE functions in the form of member function pointers |
ode_funct_mfptr_param< tclass, param_t, vec_t > | Provide ODE functions in the form of member function pointers |
ode_it_funct< vec_t > | Function class for ode_it_solve |
ode_it_funct_fptr< vec_t > | Function pointer for ode_it_solve |
ode_it_funct_mfptr< tclass, vec_t > | Member function pointer for ode_it_solve |
ode_it_solve< func_t, vec_t, mat_t, matrix_row_t, solver_vec_t, solver_mat_t > | ODE solver using a generic linear solver to solve finite-difference equations |
ode_iv_solve< func_t, vec_t, alloc_vec_t, alloc_t > | Solve an initial-value ODE problems given an adaptive ODE stepper |
ode_iv_table< func_t, vec_t, alloc_vec_t, alloc_t > | Solve an initial-value ODE problem and store the result in a table object |
ode_jac_funct< vec_t, mat_t > | Ordinary differential equation Jacobian [abstract base] |
ode_jac_funct_cmfptr< tclass, vec_t, mat_t > | Provide ODE Jacobian in the form of const member function pointers |
ode_jac_funct_fptr< vec_t, mat_t > | Provide ODE Jacobian in the form of function pointers |
ode_jac_funct_mfptr< tclass, vec_t, mat_t > | Provide ODE Jacobian in the form of member function pointers |
ode_step< func_t, vec_t > | ODE stepper base [abstract base] |
ofmatrix< N, M > | |
ofvector< N > | A vector where the memory allocation is performed in the constructor |
ofvector_cx< N > | A complex vector where the memory allocation is performed in the constructor |
omatrix_alloc | A simple class to provide an allocate() function for omatrix |
omatrix_array_tlate< data_t, mparent_t, block_t > | Create a matrix from an array |
omatrix_base_tlate< data_t, mparent_t, block_t > | A base class for omatrix and omatrix_view |
omatrix_col_tlate< data_t, mparent_t, vparent_t, block_t > | Create a vector from a column of a matrix |
omatrix_const_col_tlate< data_t, mparent_t, vparent_t, block_t > | Create a const vector from a column of a matrix |
omatrix_const_diag_tlate< data_t, mparent_t, vparent_t, block_t > | Create a vector from the main diagonal |
omatrix_const_row_tlate< data_t, mparent_t, vparent_t, block_t > | Create a const vector from a row of a matrix |
omatrix_const_view_tlate< data_t, mparent_t, block_t > | A const matrix view of omatrix objects |
omatrix_cx_col_tlate< data_t, mparent_t, vparent_t, block_t, complex_t > | Create a vector from a column of a matrix |
omatrix_cx_const_col_tlate< data_t, mparent_t, vparent_t, block_t, complex_t > | Create a vector from a column of a matrix |
omatrix_cx_const_row_tlate< data_t, mparent_t, vparent_t, block_t, complex_t > | Create a vector from a row of a matrix |
omatrix_cx_row_tlate< data_t, mparent_t, vparent_t, block_t, complex_t > | Create a vector from a row of a matrix |
omatrix_cx_tlate< data_t, parent_t, block_t, complex_t > | A matrix of double-precision numbers |
omatrix_cx_view_tlate< data_t, parent_t, block_t, complex_t > | A matrix view of double-precision numbers |
omatrix_diag_tlate< data_t, mparent_t, vparent_t, block_t > | Create a vector from the main diagonal |
omatrix_row_tlate< data_t, mparent_t, vparent_t, block_t > | Create a vector from a row of a matrix |
omatrix_tlate< data_t, mparent_t, vparent_t, block_t > | A matrix of double-precision numbers |
omatrix_view_tlate< data_t, mparent_t, block_t > | A matrix view of double-precision numbers |
ool_constr_mmin< func_t, dfunc_t, hfunc_t, vec_t, alloc_vec_t, alloc_t > | Constrained multidimensional minimization (OOL) [abstract base] |
ool_hfunct< vec_t > | Hessian product function for ool_constr_mmin [abstract base] |
ool_hfunct_fptr< vec_t > | A hessian product supplied by a function pointer |
ool_hfunct_mfptr< tclass, vec_t > | A hessian product supplied by a member function pointer |
ool_mmin_gencan< param_t, func_t, dfunc_t, hfunc_t, vec_t, alloc_vec_t, alloc_t > | Constrained minimization by the "GENCAN" method (OOL) |
ool_mmin_pgrad< func_t, dfunc_t, vec_t, alloc_vec_t, alloc_t > | Constrained minimization by the projected gradient method (OOL) |
ool_mmin_spg< func_t, dfunc_t, vec_t, alloc_vec_t, alloc_t > | Constrained minimization by the spectral projected gradient method (OOL) |
other_todos_and_bugs | An empty class to add some items to the todo and bug lists |
ovector_alloc | A simple class to provide an allocate() function for ovector |
ovector_array_stride_tlate< data_t, vparent_t, block_t > | Create a vector from an array with a stride |
ovector_array_tlate< data_t, vparent_t, block_t > | Create a vector from an array |
ovector_base_tlate< data_t, vparent_t, block_t > | A base class for ovector and ovector_view |
ovector_const_array_stride_tlate< data_t, vparent_t, block_t > | Create a const vector from an array with a stride |
ovector_const_array_tlate< data_t, vparent_t, block_t > | Create a const vector from an array |
ovector_const_reverse_tlate< data_t, vparent_t, block_t > | Reversed view of a vector |
ovector_const_subvector_reverse_tlate< data_t, vparent_t, block_t > | Reversed view of a const subvector |
ovector_const_subvector_tlate< data_t, vparent_t, block_t > | Create a const vector from a subvector of another vector |
ovector_const_view_tlate< data_t, vparent_t, block_t > | A const vector view with finite stride |
ovector_cx_array_stride_tlate< data_t, vparent_t, block_t, complex_t > | Create a vector from an array with a stride |
ovector_cx_array_tlate< data_t, vparent_t, block_t, complex_t > | Create a vector from an array |
ovector_cx_const_array_stride_tlate< data_t, vparent_t, block_t, complex_t > | Create a vector from an array_stride |
ovector_cx_const_array_tlate< data_t, vparent_t, block_t, complex_t > | Create a vector from an array |
ovector_cx_const_subvector_tlate< data_t, vparent_t, block_t, complex_t > | Create a vector from a subvector of another |
ovector_cx_imag_tlate< data_t, vparent_t, block_t, cvparent_t, cblock_t, complex_t > | Create a imaginary vector from the imaginary parts of a complex vector |
ovector_cx_real_tlate< data_t, vparent_t, block_t, cvparent_t, cblock_t, complex_t > | Create a real vector from the real parts of a complex vector |
ovector_cx_subvector_tlate< data_t, vparent_t, block_t, complex_t > | Create a vector from a subvector of another |
ovector_cx_tlate< data_t, vparent_t, block_t, complex_t > | A vector of double-precision numbers |
ovector_cx_view_tlate< data_t, vparent_t, block_t, complex_t > | A vector view of double-precision numbers |
ovector_int_alloc | A simple class to provide an allocate() function for ovector_int |
ovector_reverse_tlate< data_t, vparent_t, block_t > | Reversed view of a vector |
ovector_subvector_reverse_tlate< data_t, vparent_t, block_t > | Reversed view of a subvector |
ovector_subvector_tlate< data_t, vparent_t, block_t > | Create a vector from a subvector of another |
ovector_tlate< data_t, vparent_t, block_t > | A vector with finite stride |
ovector_view_tlate< data_t, vparent_t, block_t > | A vector view with finite stride |
cli::parameter | Parameter for cli |
cli::parameter_bool | String parameter for cli |
cli::parameter_double | Double parameter for cli |
cli::parameter_int | Integer parameter for cli |
cli::parameter_string | String parameter for cli |
permutation | A class for representing permutations |
pinside | Test line intersection and point inside polygon |
planar_intp< vec_t, mat_t > | Interpolate among two independent variables with planes |
pinside::point | Internal point definition for pinside |
o2scl_linalg::pointer_2_mem | Allocation object for 2 C-style arrays of equal size |
pointer_2d_alloc< base_t > | A simple class to provide an allocate() function for pointers |
o2scl_linalg::pointer_4_mem | Allocation object for 4 C-style arrays of equal size |
o2scl_linalg::pointer_5_mem | Allocation object for 5 C-style arrays of equal size |
pointer_alloc< base_t > | A simple class to provide an allocate() function for pointers |
pointer_2d_alloc< base_t >::pointer_comp | |
poly_complex | Solve a general polynomial with complex coefficients [abstract base] |
poly_real_coeff | Solve a general polynomial with real coefficients and complex roots [abstract base] |
polylog | Polylogarithms (approximate) ![]() |
quadratic_complex | Solve a quadratic polynomial with complex coefficients and complex roots [abstract base] |
quadratic_real | Solve a quadratic polynomial with real coefficients and real roots [abstract base] |
quadratic_real_coeff | Solve a quadratic polynomial with real coefficients and complex roots [abstract base] |
quadratic_std_complex | Solve a quadratic with complex coefficients and complex roots |
quartic_complex | Solve a quartic polynomial with complex coefficients and complex roots [abstract base] |
quartic_real | Solve a quartic polynomial with real coefficients and real roots [abstract base] |
quartic_real_coeff | Solve a quartic polynomial with real coefficients and complex roots [abstract base] |
rnga | Random number generator base |
root< func_t, dfunc_t > | One-dimensional solver [abstract base] |
root_bkt< func_t, dfunc_t > | One-dimensional bracketing solver [abstract base] |
root_de< func_t, dfunc_t > | One-dimensional with solver with derivatives [abstract base] |
scalar_ev | Scalar expectation value |
search_vec< vec_t > | Searching class for monotonic data with caching |
search_vec_ext< vec_t > | An extended search_vec which is allowed to return the last element |
sim_anneal< func_t, vec_t, rng_t > | Simulated annealing base |
simple_grad< func_t, vec_t > | Simple automatic computation of gradient by finite differencing |
simple_jacobian< func_t, vec_t, mat_t, alloc_vec_t, alloc_t > | Simple automatic Jacobian |
simple_quartic_complex | Solve a quartic with complex coefficients and complex roots |
simple_quartic_real | Solve a quartic with real coefficients and real roots |
sma_interp< n > | A specialization of smart_interp for C-style double arrays |
sma_interp_vec< arr_t > | A specialization of smart_interp_vec for C-style double arrays |
smart_interp< vec_t, svec_t > | Smart interpolation class |
smart_interp_vec< vec_t, svec_t, alloc_vec_t, alloc_t > | Smart interpolation class with pre-specified vectors |
table::sortd_s | A structure for sorting in table [protected] |
string_comp | Simple string comparison |
table | Data table class |
table3d | A data structure containing many slices of two-dimensional data points defined on a grid |
table_units | Data table class with units |
tensor | Tensor class with arbitrary dimensions |
tensor1 | Rank 1 tensor |
tensor2 | Rank 2 tensor |
tensor3 | Rank 3 tensor |
tensor4 | Rank 4 tensor |
tensor_grid | Tensor class with arbitrary dimensions with a grid |
tensor_grid1 | Rank 1 tensor with a grid |
tensor_grid2 | Rank 2 tensor with a grid |
tensor_grid3 | Rank 3 tensor with a grid |
tensor_grid4 | Rank 4 tensor with a grid |
tensor_old | Tensor_Old class with arbitrary dimensions |
tensor_old1 | Rank 1 tensor_old |
tensor_old2 | Rank 2 tensor_old |
tensor_old3 | Rank 3 tensor_old |
tensor_old4 | Rank 4 tensor_old |
tensor_old_grid | Tensor_Old class with arbitrary dimensions with a grid |
tensor_old_grid1 | Rank 2 tensor_old with a grid |
tensor_old_grid2 | Rank 2 tensor_old with a grid |
tensor_old_grid3 | Rank 3 tensor_old with a grid |
tensor_old_grid4 | Rank 4 tensor_old with a grid |
test_mgr | A class to manage testing and record success and failure |
twod_eqi_intp | Two-dimensional interpolation for equally-spaced intervals |
twod_intp | Two-dimensional interpolation class |
ufmatrix< N, M > | A matrix where the memory allocation is performed in the constructor |
ufmatrix_cx< N, M > | A matrix where the memory allocation is performed in the constructor |
ufvector< N > | A vector with unit-stride where the memory allocation is performed in the constructor |
umatrix_alloc | A simple class to provide an allocate() function for umatrix |
umatrix_base_tlate< data_t > | A matrix view of double-precision numbers |
umatrix_const_row_tlate< data_t > | Create a const vector from a row of a matrix |
umatrix_const_view_tlate< data_t > | A matrix view of double-precision numbers |
umatrix_cx_alloc | A simple class to provide an allocate() function for umatrix_cx |
umatrix_cx_const_row_tlate< data_t, complex_t > | Create a const vector from a row of a matrix |
umatrix_cx_row_tlate< data_t, complex_t > | Create a vector from a row of a matrix |
umatrix_cx_tlate< data_t, complex_t > | A matrix of double-precision numbers |
umatrix_cx_view_tlate< data_t, complex_t > | A matrix view of complex numbers |
umatrix_row_tlate< data_t > | Create a vector from a row of a matrix |
umatrix_tlate< data_t > | A matrix of double-precision numbers |
umatrix_view_tlate< data_t > | A matrix view of double-precision numbers |
uniform_grid< data_t > | A class representing a uniform linear or logarithmic grid |
uniform_grid_end< data_t > | Linear grid with fixed number of bins and fixed endpoint |
uniform_grid_end_width< data_t > | Linear grid with fixed endpoint and fixed bin size |
uniform_grid_log_end< data_t > | Logarithmic grid with fixed number of bins and fixed endpoint |
uniform_grid_log_end_width< data_t > | Logarithmic grid with fixed endpoint and fixed bin size |
uniform_grid_log_width< data_t > | Logarithmic grid with fixed number of bins and fixed bin size |
uniform_grid_width< data_t > | Linear grid with fixed number of bins and fixed bin size |
convert_units::unit_t | The type for caching unit conversions |
o2scl_linalg::uvector_2_mem | Allocation object for 2 arrays of equal size |
o2scl_linalg::uvector_4_mem | Allocation object for 4 arrays of equal size |
o2scl_linalg::uvector_5_mem | Allocation object for 5 arrays of equal size |
uvector_alloc | A simple class to provide an allocate() function for uvector |
uvector_array_tlate< data_t > | Create a vector from an array |
uvector_base_tlate< data_t > | A base class for uvector and uvector_view |
uvector_const_array_tlate< data_t > | Create a vector from an const array |
uvector_const_subvector_tlate< data_t > | Create a const vector from a subvector of another vector |
uvector_const_view_tlate< data_t > | A const vector view with unit stride |
uvector_cx_array_tlate< data_t, complex_t > | Create a vector from an array |
uvector_cx_const_array_tlate< data_t, complex_t > | Create a vector from an array |
uvector_cx_const_subvector_tlate< data_t, complex_t > | Create a vector from a subvector of another |
uvector_cx_subvector_tlate< data_t, complex_t > | Create a vector from a subvector of another |
uvector_cx_tlate< data_t, complex_t > | A vector of double-precision numbers with unit stride |
uvector_cx_view_tlate< data_t, complex_t > | A vector view of complex numbers with unit stride |
uvector_int_alloc | A simple class to provide an allocate() function for uvector_int |
uvector_size_t_alloc | A simple class to provide an allocate() function for uvector_size_t |
uvector_subvector_tlate< data_t > | Create a vector from a subvector of another |
uvector_tlate< data_t > | A vector with unit stride |
uvector_view_tlate< data_t > | A base class for uvectors |
vector_ev | Vector expectation value |
xmatrix | A version of omatrix with better error checking |
Documentation generated with Doxygen. Provided under the GNU Free Documentation License (see License Information).