►Nboost | Placeholder documentation of some related Boost objects |
►Nnumeric | Documentation of Boost::numeric objects |
►Nublas | Documentation of uBlas objects |
Cmatrix | The default matrix type from uBlas |
Cvector | The default vector type from uBlas |
►No2scl | The main O2scl namespace |
Canneal_base | Simulated annealing base |
Canneal_gsl | Multidimensional minimization by simulated annealing (GSL) |
Canneal_mt | Multidimensional minimization by simulated annealing (Boost multi-threaded version) |
Canneal_para | Multidimensional minimization by simulated annealing (OpenMP/MPI version) |
Castep_base | Adaptive stepper [abstract base] |
Castep_gsl | Adaptive ODE stepper (GSL) |
Castep_nonadapt | An non-adaptive stepper implementation of astep_base |
Ccalculator | Evaluate a mathematical expression in a string |
Ccheb_approx | Chebyshev approximation (GSL) |
Cchi_fit_funct | Standard fitting function based on one-dimensional data with a numerical Jacobian |
►Ccli | Configurable command-line interface |
Cparameter | Parameter for o2scl::cli |
Cparameter_bool | String parameter for o2scl::cli |
Cparameter_double | Double parameter for o2scl::cli |
Cparameter_int | Integer parameter for o2scl::cli |
Cparameter_size_t | Integer parameter for o2scl::cli |
Cparameter_string | String parameter for o2scl::cli |
Ccli_readline | An extension to o2scl::cli which uses readline |
Ccmd_line_arg | A command-line argument for o2scl::cli |
Ccolumnify | Create nicely formatted columns from a table of strings |
Ccomm_option_fptr | Function pointer for o2scl::cli command function |
Ccomm_option_funct | Base for o2scl::cli command function |
Ccomm_option_mfptr | Member function pointer for o2scl::cli command function |
Ccomm_option_s | Command for interactive mode in o2scl::cli |
Cconst_matrix_column_gen | Generic object which represents a column of a const matrix |
Cconst_matrix_row_gen | Generic object which represents a row of a matrix |
Cconst_vector_range_gen | Experimental const vector range object |
Ccontour | Calculate contour lines from a two-dimensional data set |
Ccontour_line | A contour line |
►Cconvert_units | Convert units |
Cunit_t | The type for caching unit conversions |
Ccubic_complex | Solve a cubic polynomial with complex coefficients and complex roots [abstract base] |
Ccubic_complex_std | Solve a cubic with complex coefficients and complex roots |
Ccubic_real | Solve a cubic polynomial with real coefficients and real roots [abstract base] |
Ccubic_real_coeff | Solve a cubic polynomial with real coefficients and complex roots [abstract base] |
Ccubic_real_coeff_cern | Solve a cubic with real coefficients and complex roots (CERNLIB) |
Ccubic_real_coeff_gsl | Solve a cubic with real coefficients and complex roots (GSL) |
►Cderiv_base | Numerical differentiation base [abstract base] |
Cdpars | A structure for passing the function to second and third derivatives [protected] |
Cderiv_cern | Numerical differentiation routine (CERNLIB) |
Cderiv_eqi | Derivatives for equally-spaced abscissas |
Cderiv_gsl | Numerical differentiation (GSL) |
Cdiff_evo | Multidimensional minimization by the differential evolution method |
Cdiff_evo_adapt | Multidimensional minimization by the differential evolution method |
Cedge_crossings | Edges for the contour class |
Cerr_hnd_cpp | Error handler to throw C++ exceptions |
Cerr_hnd_gsl | The error handler |
Cerr_hnd_type | Class defining an error handler [abstract base] |
Cexc_exception | Generic exception |
Cexc_invalid_argument | Invalid argument exception |
Cexc_ios_failure | I/O failure error exception |
Cexc_logic_error | Logic error exception |
Cexc_overflow_error | Overflow error runtime exception |
Cexc_range_error | Range error runtime exception |
Cexc_runtime_error | Generic runtime error exception |
Cexpval_base | Expectation value base class |
Cexpval_matrix | Matrix expectation value |
Cexpval_scalar | Scalar expectation value |
Cexpval_vector | Vector expectation value |
Cfit_base | Non-linear least-squares fitting [abstract base] |
Cfit_bayes | Fit a function to data using Bayesian methods |
Cfit_fix_pars | Multidimensional fitting class fixing some parameters and varying others |
Cfit_funct_strings | String fitting function |
Cfit_linear | Linear least-squares fitting class (GSL) |
Cfit_min | Non-linear least-squares fitting class with generic minimizer |
Cfit_nonlin | Non-linear least-squares fitting class (GSL) |
Cfit_nonlin_b | Base routines for the nonlinear fitting classes |
Cformat_float | Format a floating point number into a Latex or HTML string |
Cfunct2_string | Two-dimensional function from a string |
Cfunct_gsl | A wrapper to specify o2scl::funct objects to GSL |
Cfunct_string | One-dimensional function from a string |
Cgen_fit_funct | Generalized fitting function [abstract base] |
Cgen_test_number | Generate number sequence for testing |
Cgradient | Class for automatically computing gradients [abstract base] |
Cgradient_gsl | Simple automatic computation of gradient by finite differencing |
Cgsl_matrix_wrap | A simple convenience wrapper for GSL matrix objects |
Cgsl_tolerance | Convergence test similar to gsl_root_test_interval() for root_toms748 |
Cgsl_vector_wrap | A simple convenience wrapper for GSL vector objects |
Chist | A one-dimensional histogram class |
Chist_2d | A two-dimensional histogram class |
Cinte | Base integration class [abstract base] |
Cinte_adapt_cern | Adaptive integration (CERNLIB) |
Cinte_cauchy_cern | Cauchy principal value integration (CERNLIB) |
Cinte_cheb_gsl | Chebyshev integration base class (GSL) |
Cinte_cubature_base | Base class for integration routines from the Cubature library |
Cinte_gauss56_cern | 5,6-point Gaussian quadrature (CERNLIB) |
Cinte_gauss_cern | Gaussian quadrature (CERNLIB) |
Cinte_gen | Generalized multi-dimensional integration [abstract base] |
Cinte_gsl | GSL integration base |
►Cinte_hcubature | Adaptive multidimensional integration on hyper-rectangles using cubature rules from the Cubature library |
Cesterr | A value and error |
Cheap | Desc |
Chypercube | Desc |
Cregion | Desc |
Crule | Desc |
Crule75genzmalik | Desc |
Cinte_kronrod_gsl | Basic Gauss-Kronrod integration class (GSL) |
Cinte_multi | Multi-dimensional integration over a hypercube [abstract base] |
►Cinte_pcubature | Integration by p-adaptive cubature from the Cubature library |
Ccache | Cache of the values for the m[dim] grid |
Cinte_qag_gsl | Adaptive numerical integration of a function (without singularities) on a bounded interval (GSL) |
Cinte_qagi_gsl | Integrate a function over the interval ![]() |
Cinte_qagil_gsl | Integrate a function over the interval ![]() |
Cinte_qagiu_gsl | Integrate a function over the interval ![]() |
Cinte_qags_gsl | Integrate a function with a singularity (GSL) |
Cinte_qawc_gsl | Adaptive Cauchy principal value integration (GSL) |
Cinte_qawf_gsl_cos | Adaptive integration a function with finite limits of integration (GSL) |
Cinte_qawf_gsl_sin | Adaptive integration for oscillatory integrals (GSL) |
Cinte_qawo_gsl_cos | Adaptive integration a function with finite limits of integration (GSL) |
Cinte_qawo_gsl_sin | Adaptive integration for oscillatory integrals (GSL) |
Cinte_qaws_gsl | Adaptive integration with with algebraic-logarithmic singularities at the end-points (GSL) |
Cinte_qng_gsl | Non-adaptive integration from a to b (GSL) |
►Cinte_singular_gsl | Base class for integrating a function with a singularity (GSL) |
Cextrapolation_table | A structure for extrapolation for inte_qags_gsl |
Cinte_transform_gsl | Integrate a function with a singularity (GSL) [abstract base] |
Cinte_workspace_gsl | Integration workspace for the GSL integrators |
Cinterp | Interpolation class for general vectors |
Cinterp2_base | Two-dimensional interpolation base class [abstract] |
Cinterp2_direct | Bilinear or bicubic two-dimensional interpolation |
Cinterp2_eqi | Two-dimensional interpolation for equally-spaced intervals |
Cinterp2_neigh | Nearest-neighbor interpolation in two dimensions |
Cinterp2_planar | Interpolate among two independent variables with planes |
Cinterp2_seq | Two-dimensional interpolation class by successive one-dimensional interpolation |
Cinterp_akima | Akima spline interpolation (GSL) |
Cinterp_akima_peri | Akima spline interpolation with periodic boundary conditions (GSL) |
Cinterp_array | A specialization of interp for C-style double arrays |
Cinterp_array_vec | A specialization of o2scl::interp_vec for C-style arrays |
Cinterp_base | Base low-level interpolation class [abstract base] |
Cinterp_cspline | Cubic spline interpolation (GSL) |
Cinterp_cspline_peri | Cubic spline interpolation with periodic boundary conditions (GSL) |
Cinterp_krige | Interpolation by Kriging with a user-specified covariance function |
Cinterp_krige_optim | One-dimensional interpolation using an optimized covariance function |
Cinterp_linear | Linear interpolation (GSL) |
Cinterp_monotonic | Monotonicity-preserving interpolation |
Cinterp_nearest_neigh | Nearest-neighbor interpolation |
Cinterp_steffen | Steffen's monotonicity-preserving interpolation |
Cinterp_vec | Interpolation class for pre-specified vector |
Cinterpm_idw | Multi-dimensional interpolation by inverse distance weighting |
Cinterpm_krige | Multi-dimensional interpolation by kriging |
Cinterpm_krige_nn | Multi-dimensional interpolation by kriging with nearest-neighbor |
Cjacobian | Base for providing a numerical jacobian [abstract base] |
►Cjacobian_exact | A direct calculation of the jacobian using a deriv_base object |
Cej_parms | Parameter structure for passing information |
Cjacobian_gsl | Simple automatic Jacobian |
Clib_settings_class | A class to manage global library settings |
Cmatrix_column_gen | Generic object which represents a column of a matrix |
Cmatrix_row_gen | Generic object which represents a row of a matrix |
Cmatrix_view | A simple matrix view object |
Cmatrix_view_table | View a o2scl::table object as a matrix |
Cmcarlo | Monte-Carlo integration [abstract base] |
Cmcarlo_miser | Multidimensional integration using the MISER Monte Carlo algorithm (GSL) |
Cmcarlo_plain | Multidimensional integration using plain Monte Carlo (GSL) |
Cmcarlo_vegas | Multidimensional integration using Vegas Monte Carlo (GSL) |
Cmcmc_para_base | A generic MCMC simulation class |
Cmcmc_para_cli | MCMC class with a command-line interface |
Cmcmc_para_old_base | A generic MCMC simulation class |
Cmcmc_para_old_cli | MCMC class with a command-line interface |
Cmcmc_para_old_table | A generic MCMC simulation class writing data to a o2scl::table_units object |
Cmcmc_para_table | A generic MCMC simulation class writing data to a o2scl::table_units object |
Cmin_base | One-dimensional minimization [abstract base] |
Cmin_bkt_base | One-dimensional bracketing minimization [abstract base] |
Cmin_brent_boost | One-dimensional minimization using Brent's method (GSL) |
Cmin_brent_gsl | One-dimensional minimization using Brent's method (GSL) |
Cmin_cern | One-dimensional minimization (CERNLIB) |
Cmin_de_base | One-dimensional minimization using derivatives [abstract base] |
Cmin_quad_golden | Minimization of a function using the safeguarded step-length algorithm of Gill and Murray [GSL] |
Cmm_funct_strings | Array of multi-dimensional functions in an array of strings |
Cmmin_base | Multidimensional minimization [abstract base] |
Cmmin_bfgs2 | Multidimensional minimization by the BFGS algorithm (GSL) |
Cmmin_conf | Multidimensional minimization by the Fletcher-Reeves conjugate gradient algorithm (GSL) |
Cmmin_conp | Multidimensional minimization by the Polak-Ribiere conjugate gradient algorithm (GSL) |
Cmmin_constr | Constrained multidimensional minimization (OOL) [abstract base] |
Cmmin_constr_gencan | Constrained minimization by the "GENCAN" method (OOL) |
Cmmin_constr_pgrad | Constrained minimization by the projected gradient method (OOL) |
Cmmin_constr_spg | Constrained minimization by the spectral projected gradient method (OOL) |
Cmmin_fix_params | Multidimensional minimizer fixing some parameters and varying others |
Cmmin_gsl_base | Base minimization routines for mmin_conf and mmin_conp |
Cmmin_linmin_gsl | The line minimizer for mmin_bfgs2 |
Cmmin_simp2 | Multidimensional minimization by the Simplex method (v2) (GSL) |
Cmmin_wrap_gsl | Virtual base for the mmin_bfgs2 wrapper |
Cmmin_wrapper_gsl | Wrapper class for the mmin_bfgs2 minimizer |
Cmroot | Multidimensional root-finding [abstract base] |
Cmroot_broyden | Multidimensional root-finding using Broyden's method (GSL) |
Cmroot_cern | Multi-dimensional mroot-finding routine (CERNLIB) |
Cmroot_hybrids | Multidimensional root-finding algorithm using Powell's Hybrid method (GSL) |
Cmroot_hybrids_arma_qr_econ | A version of mroot_hybrids which uses Armadillo for the QR decomposition |
Cmroot_hybrids_base | Base functions for mroot_hybrids |
Cmroot_hybrids_eigen | A version of mroot_hybrids which uses Eigen for the QR decomposition |
Cmulti_funct_strings | A multi-dimensional function from a string |
Code_bsimp_gsl | Bulirsch-Stoer implicit ODE stepper (GSL) |
Code_bv_mshoot | Solve boundary-value ODE problems by multishooting with a generic nonlinear solver |
Code_bv_multishoot | Solve a ODE boundary value problem by multishooting |
Code_bv_shoot | Solve boundary-value ODE problems by shooting from one boundary to the other |
Code_bv_shoot_grid | Solve boundary-value ODE problems by shooting from one boundary to the other on a grid |
Code_bv_solve | Base class for boundary-value ODE solvers |
Code_control_gsl | Control structure for astep_gsl |
Code_funct_strings | One-dimensional function from strings |
Code_it_solve | ODE solver using a generic linear solver to solve finite-difference equations |
Code_iv_solve | Solve an initial-value ODE problems given an adaptive ODE stepper |
Code_iv_table | Solve an initial-value ODE problem and store the result in a table object |
Code_rk8pd_gsl | Embedded Runge-Kutta Prince-Dormand ODE stepper (GSL) |
Code_rkck_gsl | Cash-Karp embedded Runge-Kutta ODE stepper (GSL) |
Code_rkf45_gsl | Runge-Kutta-Fehlberg embedded Runge-Kutta ODE stepper (GSL) |
Code_step | ODE stepper base [abstract base] |
Cpermutation | A class for representing permutations |
►Cpinside | Test line intersection and point inside polygon |
Cline | Internal line definition for pinside |
Cpoint | Internal point definition for pinside |
Cpoly_complex | Solve a general polynomial with complex coefficients [abstract base] |
Cpoly_real_coeff | Solve a general polynomial with real coefficients and complex roots [abstract base] |
Cpoly_real_coeff_gsl | Solve a general polynomial with real coefficients (GSL) |
Cpolylog | Polylogarithms (approximate) ![]() |
Cprob_cond_mdim | A multi-dimensional conditional probability density function |
Cprob_cond_mdim_fixed_step | Conditional probability for a random walk inside a hypercube |
Cprob_cond_mdim_gaussian | A multi-dimensional Gaussian conditional probability density function |
Cprob_cond_mdim_indep | A multi-dimensional conditional probability density function independent of the input |
Cprob_dens_frange | A one-dimensional probability density over a finite range |
Cprob_dens_func | A one-dimensional probability density function |
Cprob_dens_gaussian | A one-dimensional Gaussian probability density |
Cprob_dens_hist | Probability density function based on a histogram |
Cprob_dens_lognormal | Lognormal density function |
Cprob_dens_mdim | A multi-dimensional probability density function |
►Cprob_dens_mdim_amr | Probability distribution from an adaptive mesh created using a matrix of points |
Chypercube | A hypercube class for o2scl::prob_dens_mdim_amr |
Cprob_dens_mdim_biv_gaussian | A bivariate gaussian probability distribution |
Cprob_dens_mdim_bound_gaussian | Gaussian distribution bounded by a hypercube |
Cprob_dens_mdim_factor | A multidimensional distribution formed by the product of several one-dimensional distributions |
Cprob_dens_mdim_gaussian | A multi-dimensional Gaussian probability density function using a Cholesky decomposition |
Cprob_dens_positive | A one-dimensional probability density over the positive real numbers |
Cprob_dens_uniform | A uniform one-dimensional probability density over a finite range |
Cquadratic_complex | Solve a quadratic polynomial with complex coefficients and complex roots [abstract base] |
Cquadratic_complex_std | Solve a quadratic with complex coefficients and complex roots |
Cquadratic_real | Solve a quadratic polynomial with real coefficients and real roots [abstract base] |
Cquadratic_real_coeff | Solve a quadratic polynomial with real coefficients and complex roots [abstract base] |
Cquadratic_real_coeff_gsl | Solve a quadratic with real coefficients and complex roots (GSL) |
Cquartic_complex | Solve a quartic polynomial with complex coefficients and complex roots [abstract base] |
Cquartic_complex_simple | Solve a quartic with complex coefficients and complex roots |
Cquartic_real | Solve a quartic polynomial with real coefficients and real roots [abstract base] |
Cquartic_real_coeff | Solve a quartic polynomial with real coefficients and complex roots [abstract base] |
Cquartic_real_coeff_cern | Solve a quartic with real coefficients and complex roots (CERNLIB) |
Cquartic_real_gsl | Solve a quartic with real coefficients and real roots (GSL) |
Cquartic_real_gsl2 | Solve a quartic with real coefficients and real roots (GSL) |
Cquartic_real_simple | Solve a quartic with real coefficients and real roots |
Crng_gsl | Random number generator (GSL) |
Crng_gsl_uniform_real | An alternative RNG type used to design templates for either GSL or STL random number generators |
Croot | One-dimensional solver [abstract base] |
Croot_bkt | One-dimensional bracketing solver [abstract base] |
Croot_bkt_cern | One-dimensional root-finding routine (CERNLIB) |
Croot_brent_gsl | One-dimensional root-finding (GSL) |
Croot_cern | One-dimensional version of cern_mroot |
Croot_de | One-dimensional with solver with derivatives [abstract base] |
Croot_robbins_monro | One-dimensional root-finding for noisy functions |
Croot_stef | Steffenson equation solver (GSL) |
Croot_toms748 | Bracketing solver based the Boost implementation of TOMS 748 |
Csearch_vec | Searching class for monotonic data with caching |
Csearch_vec_ext | An extended search_vec which is allowed to return the last element |
Cseries_acc | Series acceleration by Levin u-transform (GSL) |
Csmooth_func | Smooth a function by averaging in a neighborhood of points defined by a Sobol sequence |
Csmooth_gsl | Smooth a GSL vector using GSL bsplines |
►Ctable | Data table class |
Ccol | Column structure for table [protected] |
Ctable3d | A data structure containing one or more slices of two-dimensional data points defined on a grid |
Ctable_units | Data table class with units |
Ctensor | Tensor class with arbitrary dimensions |
Ctensor1 | Rank 1 tensor |
Ctensor2 | Rank 2 tensor |
Ctensor3 | Rank 3 tensor |
Ctensor4 | Rank 4 tensor |
Ctensor_grid | Tensor class with arbitrary dimensions with a grid |
Ctensor_grid1 | Rank 1 tensor with a grid |
Ctensor_grid2 | Rank 2 tensor with a grid |
Ctensor_grid3 | Rank 3 tensor with a grid |
Ctensor_grid4 | Rank 4 tensor with a grid |
Ctest_mgr | A class to manage testing and record success and failure |
CToken | Token class for o2scl::calculator |
CTokenBase | Token base data type for o2scl::calculator |
Cuniform_grid | A class representing a uniform linear or logarithmic grid |
Cuniform_grid_end | Linear grid with fixed number of bins and fixed endpoint |
Cuniform_grid_end_width | Linear grid with fixed endpoint and fixed bin size |
Cuniform_grid_log_end | Logarithmic grid with fixed number of bins and fixed endpoint |
Cuniform_grid_log_end_width | Logarithmic grid with fixed endpoint and fixed bin size |
Cuniform_grid_log_width | Logarithmic grid with fixed number of bins and fixed bin size |
Cuniform_grid_width | Linear grid with fixed number of bins and fixed bin size |
Cuniform_prior | An unnormalized uniform prior distribution for several variables |
Cvec_index | A class to assign string labels to array indices |
Cvector_range_gen | Experimental vector range object |
►No2scl_acol | A namespace for objects associated with the command-line utility 'acol' |
Cacol_manager | The driver for 'acol' command-line utility |
►No2scl_hdf | The O2scl namespace for I/O with HDF |
Ccloud_file | Read a file and download from a URL if necessary |
►Chdf_file | Store data in an O2scl compatible HDF5 file |
Citerate_parms | Parameters for iterate_func() |
►No2scl_linalg | The namespace for linear algebra classes and functions |
Clanczos | Lanczos diagonalization |
Clinear_solver | A generic solver for the linear system ![]() |
Clinear_solver_arma | Armadillo linear solver |
Clinear_solver_eigen_colQR | Eigen linear solver using QR decomposition with column pivoting |
Clinear_solver_eigen_fullLU | Eigen linear solver using LU decomposition with full pivoting |
Clinear_solver_eigen_fullQR | Eigen linear solver using QR decomposition with full pivoting |
Clinear_solver_eigen_houseQR | Eigen linear solver using QR decomposition with column pivoting |
Clinear_solver_eigen_LDLT | Eigen linear solver using LDLT decomposition with full pivoting |
Clinear_solver_eigen_LLT | Eigen linear solver using LLT decomposition with full pivoting |
Clinear_solver_eigen_partLU | Eigen linear solver using LU decomposition with partial pivoting |
Clinear_solver_HH | Generic Householder linear solver |
Clinear_solver_LU | Generic linear solver using LU decomposition |
Clinear_solver_QR | Generic linear solver using QR decomposition |
Cubvector_2_mem | Allocation object for 2 arrays of equal size |
Cubvector_4_mem | Allocation object for 4 arrays of equal size |
Cubvector_5_mem | Allocation object for 5 arrays of equal size |
Documentation generated with Doxygen. Provided under the
GNU Free Documentation License (see License Information).